LArSoft
v07_13_02
Liquid Argon Software toolkit - http://larsoft.org/
|
Geometry information for a single TPC. More...
#include "TPCGeo.h"
Classes | |
struct | TPCGeoCoordinatesTag |
Tag for vectors in the "local" GDML coordinate frame of the TPC. More... | |
Public Types | |
using | GeoNodePath_t = geo::WireGeo::GeoNodePath_t |
using | Projection_t = geo::PlaneGeo::WidthDepthProjection_t |
Type of 2D vector projection on a plane. More... | |
using | DecomposedVector_t = geo::PlaneGeo::WDDecomposedVector_t |
Data structure with plane and drift projections of a 3D vector. More... | |
using | Coords_t = geo::Point_t |
Type of the coordinate triplet. More... | |
using | Coord_t = Coords_t::Scalar |
Type of the coordinate. More... | |
Types for geometry-local reference vectors. | |
These types represents points and displacement vectors in the reference frame defined in the TPC geometry box from the GDML geometry description. No alias is explicitly defined for the LArSoft global vector types, Remember the | |
using | LocalPoint_t = geo::Point3DBase_t< TPCGeoCoordinatesTag > |
Type of points in the local GDML TPC frame. More... | |
using | LocalVector_t = geo::Vector3DBase_t< TPCGeoCoordinatesTag > |
Type of displacement vectors in the local GDML TPC frame. More... | |
Public Member Functions | |
TPCGeo (GeoNodePath_t &path, size_t depth) | |
PlaneGeo const & | Plane (geo::View_t view) const |
Return the plane in the tpc with View_t view. More... | |
PlaneGeo const & | Plane (unsigned int iplane) const |
PlaneGeo const * | PlanePtr (unsigned int iplane) const |
Returns the plane number iplane from this TPC. More... | |
geo::PlaneGeo const & | SmallestPlane () const |
Returns the wire plane with the smallest surface. More... | |
geo::PlaneGeo const & | FirstPlane () const |
Returns the first wire plane (the closest to TPC center). More... | |
geo::PlaneGeo const & | LastPlane () const |
Returns the last wire plane (the farther from TPC center). More... | |
unsigned int | MaxWires () const |
Returns the largest number of wires among the planes in this TPC. More... | |
std::set< geo::View_t > | Views () const |
Returns a set of all views covered in this TPC. More... | |
template<typename Point = DefaultPoint_t> | |
Point | ProjectionReferencePoint () const |
Returns the reference point used by PointProjection() . More... | |
template<typename Point = DefaultPoint_t> | |
Point | ComposePoint (DecomposedVector_t const &decomp) const |
Returns the 3D vector from composition of projection and distance. More... | |
template<typename Point = DefaultPoint_t> | |
Point | ComposePoint (double distance, Projection_t const &proj) const |
Returns the 3D point from composition of projection and distance. More... | |
short int | DetectDriftDirection () const |
Returns the expected drift direction based on geometry. More... | |
void | SortSubVolumes (geo::GeoObjectSorter const &sorter) |
Apply sorting to the PlaneGeo objects. More... | |
void | UpdateAfterSorting (geo::TPCID tpcid) |
Performs all updates after cryostat has sorted TPCs. More... | |
template<typename Stream > | |
void | PrintTPCInfo (Stream &&out, std::string indent="", unsigned int verbosity=1) const |
Prints information about this TPC. More... | |
TPC properties | |
double | ActiveHalfWidth () const |
Half width (associated with x coordinate) of active TPC volume [cm]. More... | |
double | ActiveWidth () const |
Width (associated with x coordinate) of active TPC volume [cm]. More... | |
double | ActiveHalfHeight () const |
Half height (associated with y coordinate) of active TPC volume [cm]. More... | |
double | ActiveHeight () const |
Height (associated with y coordinate) of active TPC volume [cm]. More... | |
double | ActiveLength () const |
Length (associated with z coordinate) of active TPC volume [cm]. More... | |
double | ActiveHalfLength () const |
Length (associated with z coordinate) of active TPC volume [cm]. More... | |
double | HalfWidth () const |
Width is associated with x coordinate [cm]. More... | |
double | Width () const |
Width is associated with x coordinate [cm]. More... | |
double | HalfHeight () const |
Height is associated with y coordinate [cm]. More... | |
double | Height () const |
Height is associated with y coordinate [cm]. More... | |
double | Length () const |
Length is associated with z coordinate [cm]. More... | |
double | HalfLength () const |
Length is associated with z coordinate [cm]. More... | |
double | ActiveMass () const |
Half width (associated with x coordinate) of active TPC volume [cm]. More... | |
const TGeoVolume * | ActiveVolume () const |
Half width (associated with x coordinate) of active TPC volume [cm]. More... | |
const TGeoVolume * | TotalVolume () const |
Half width (associated with x coordinate) of active TPC volume [cm]. More... | |
template<typename Vector = DefaultVector_t> | |
decltype(auto) | WidthDir () const |
Returns the direction Width() is measured on. More... | |
template<typename Vector = DefaultVector_t> | |
decltype(auto) | HeightDir () const |
Returns the direction Height() is measured on. More... | |
template<typename Vector = DefaultVector_t> | |
decltype(auto) | LengthDir () const |
Returns the direction Length() is measured on. More... | |
DriftDirection_t | DriftDirection () const |
Returns an enumerator value describing the drift direction. More... | |
template<typename Vector = DefaultVector_t> | |
Vector | DriftDir () const |
Returns the direction of the drift (vector pointing toward the planes). More... | |
double | DriftDistance () const |
Plane access | |
unsigned int | Nplanes () const |
Number of planes in this tpc. More... | |
unsigned int | NElements () const |
Number of planes in this tpc. More... | |
bool | HasPlane (unsigned int iplane) const |
Returns whether a plane with index iplane is present in this TPC. More... | |
bool | HasElement (unsigned int iplane) const |
Returns whether a plane with index iplane is present in this TPC. More... | |
bool | HasPlane (geo::PlaneID const &planeid) const |
Returns whether the plane in planeid is present in this TPC. More... | |
bool | HasElement (geo::PlaneID const &planeid) const |
Returns whether the plane in planeid is present in this TPC. More... | |
const PlaneGeo & | Plane (PlaneID const &planeid) const |
Returns the plane in planeid from this TPC. More... | |
const PlaneGeo & | GetElement (PlaneID const &planeid) const |
Returns the plane in planeid from this TPC. More... | |
PlaneGeo const * | PlanePtr (PlaneID const &planeid) const |
Returns the plane in planeid from this TPC. More... | |
PlaneGeo const * | GetElementPtr (PlaneID const &planeid) const |
Returns the plane in planeid from this TPC. More... | |
TPC geometry properties | |
template<typename Point = DefaultPoint_t> | |
Point | GetCenter () const |
Returns the center of the TPC volume in world coordinates [cm]. More... | |
template<typename Point = DefaultPoint_t> | |
Point | GetActiveVolumeCenter () const |
Returns the center of the TPC active volume in world coordinates [cm]. More... | |
template<typename Point = DefaultPoint_t> | |
Point | GetCathodeCenter () const |
template<typename Point = geo::Point_t> | |
Point | GetFrontFaceCenter () const |
Returns the center of the active TPC volume side facing negative z. More... | |
geo::BoxBoundedGeo const & | BoundingBox () const |
Returns the bounding box of this TPC. More... | |
geo::BoxBoundedGeo const & | ActiveBoundingBox () const |
Returns the box of the active volume of this TPC. More... | |
const double * | PlaneLocation (unsigned int p) const |
Returns the coordinates of the center of the specified plane [cm]. More... | |
double | Plane0Pitch (unsigned int p) const |
Returns the center of the TPC volume in world coordinates [cm]. More... | |
double | PlanePitch (unsigned int p1=0, unsigned int p2=1) const |
Returns the center of the TPC volume in world coordinates [cm]. More... | |
double | WirePitch (unsigned plane=0) const |
Returns the center of the TPC volume in world coordinates [cm]. More... | |
geo::TPCID const & | ID () const |
Returns the identifier of this TPC. More... | |
Projection on a wire plane | |
These methods deal with projection of points and vectors on a plane, using a geometric reference base which is not dependent on the wire direction. Technically, the objects are projected on the reference plane, that happens to be the first wire plane. In practice, the important bit is that all entities are consistently decomposed into a drift component and a remaining component. If which plane the projection happens on should matter, then geo::PlaneGeo can be used directly (but note that geo::PlaneGeo defines two different frames, and the names of the frame equivalent to the one used here are different). | |
geo::PlaneGeo const & | ReferencePlane () const |
Returns the plane used for reference by projection methods. More... | |
geo::PlaneID const & | ReferencePlaneID () const |
Returns the ID of the plane used for reference by projection methods. More... | |
template<typename Vector = DefaultPoint_t> | |
Vector | RefWidthDir () const |
Return the direction of reference plane width. More... | |
template<typename Vector = DefaultPoint_t> | |
Vector | RefDepthDir () const |
Return the direction of reference plane depth. More... | |
double | DistanceFromReferencePlane (geo::Point_t const &point) const |
Returns the distance of the specified point from reference plane. More... | |
double | DistanceFromReferencePlane (TVector3 const &point) const |
Returns the plane used for reference by projection methods. More... | |
void | DriftPoint (geo::Point_t &position, double distance) const |
Shifts the position of an electron drifted by a distance. More... | |
void | DriftPoint (TVector3 &position, double distance) const |
Shifts the position of an electron drifted by a distance. More... | |
DecomposedVector_t | DecomposePoint (geo::Point_t const &point) const |
Decomposes a 3D point in two components. More... | |
DecomposedVector_t | DecomposePoint (TVector3 const &point) const |
Decomposes a 3D point in two components. More... | |
Projection_t | Projection (geo::Point_t const &point) const |
Returns the projection of the specified point on the plane. More... | |
Projection_t | PointProjection (geo::Point_t const &point) const |
Returns the projection of the specified point on the plane. More... | |
Projection_t | PointProjection (TVector3 const &point) const |
Returns the projection of the specified point on the plane. More... | |
Projection_t | Projection (geo::Vector_t const &v) const |
Returns the projection of the specified vector on the plane. More... | |
Projection_t | VectorProjection (geo::Vector_t const &v) const |
Returns the projection of the specified vector on the plane. More... | |
Projection_t | VectorProjection (TVector3 const &v) const |
Returns the projection of the specified vector on the plane. More... | |
Coordinate transformation | |
void | LocalToWorld (const double *tpc, double *world) const |
Transform point from local TPC frame to world frame. More... | |
TVector3 | LocalToWorld (const TVector3 &local) const |
Transform point from local TPC frame to world frame. More... | |
geo::Point_t | toWorldCoords (LocalPoint_t const &local) const |
Transform point from local TPC frame to world frame. More... | |
void | LocalToWorldVect (const double *tpc, double *world) const |
Transform direction vector from local to world. More... | |
TVector3 | LocalToWorldVect (const TVector3 &local) const |
Transform direction vector from local to world. More... | |
geo::Vector_t | toWorldCoords (LocalVector_t const &local) const |
Transform direction vector from local to world. More... | |
void | WorldToLocal (const double *world, double *tpc) const |
Transform point from world frame to local TPC frame. More... | |
TVector3 | WorldToLocal (TVector3 const &world) const |
Transform point from world frame to local TPC frame. More... | |
LocalPoint_t | toLocalCoords (geo::Point_t const &world) const |
Transform point from world frame to local TPC frame. More... | |
void | WorldToLocalVect (const double *world, double *tpc) const |
Transform direction vector from world to local. More... | |
TVector3 | WorldToLocalVect (TVector3 const &world) const |
Transform direction vector from world to local. More... | |
LocalVector_t | toLocalCoords (geo::Vector_t const &world) const |
Transform direction vector from world to local. More... | |
Dimension queries | |
double | MinX () const |
Returns the world x coordinate of the start of the box. More... | |
double | MaxX () const |
Returns the world x coordinate of the end of the box. More... | |
double | CenterX () const |
Returns the world x coordinate of the center of the box. More... | |
double | SizeX () const |
Returns the full size in the X dimension. More... | |
double | HalfSizeX () const |
Returns the size from the center to the border on X dimension. More... | |
double | MinY () const |
Returns the world y coordinate of the start of the box. More... | |
double | MaxY () const |
Returns the world y coordinate of the end of the box. More... | |
double | CenterY () const |
Returns the world y coordinate of the center of the box. More... | |
double | SizeY () const |
Returns the full size in the Y dimension. More... | |
double | HalfSizeY () const |
Returns the size from the center to the border on Y dimension. More... | |
double | MinZ () const |
Returns the world z coordinate of the start of the box. More... | |
double | MaxZ () const |
Returns the world z coordinate of the end of the box. More... | |
double | CenterZ () const |
Returns the world z coordinate of the center of the box. More... | |
double | SizeZ () const |
Returns the full size in the Z dimension. More... | |
double | HalfSizeZ () const |
Returns the size from the center to the border on Z dimension. More... | |
geo::Point_t | Min () const |
Returns the corner point with the smallest coordinates. More... | |
geo::Point_t | Max () const |
Returns the corner point with the largest coordinates. More... | |
geo::Point_t | Center () const |
Returns the center point of the box. More... | |
Containment in the full volume | |
bool | ContainsX (double x, double const wiggle=1) const |
Returns whether this TPC contains the specified world x coordinate. More... | |
bool | ContainsY (double y, double const wiggle=1) const |
Returns whether this TPC contains the specified world y coordinate. More... | |
bool | ContainsZ (double z, double const wiggle=1) const |
Returns whether this TPC contains the specified world z coordinate. More... | |
bool | ContainsYZ (double y, double z, double const wiggle=1) const |
Returns if TPC contains the specified world y and z coordinates. More... | |
bool | ContainsPosition (geo::Point_t const &point, double wiggle=1.0) const |
Returns whether this volume contains the specified point. More... | |
bool | ContainsPosition (TVector3 const &point, double wiggle=1.0) const |
bool | ContainsPosition (double const *point, double wiggle=1.0) const |
Containment in a fiducial volume | |
bool | InFiducialX (double x, double neg_margin, double pos_margin) const |
Returns whether TPC fiducial volume contains world x coordinate. More... | |
bool | InFiducialX (double x, double margin) const |
Returns whether TPC fiducial volume contains world x coordinate. More... | |
bool | InFiducialY (double y, double neg_margin, double pos_margin) const |
Returns whether TPC fiducial volume contains world y coordinate. More... | |
bool | InFiducialY (double y, double margin) const |
Returns whether TPC fiducial volume contains world y coordinate. More... | |
bool | InFiducialZ (double z, double neg_margin, double pos_margin) const |
Returns whether TPC fiducial volume contains world z coordinate. More... | |
bool | InFiducialZ (double z, double margin) const |
Returns whether TPC fiducial volume contains world z coordinate. More... | |
Setting dimensions | |
void | SetBoundaries (Coord_t x_min, Coord_t x_max, Coord_t y_min, Coord_t y_max, Coord_t z_min, Coord_t z_max) |
Sets the boundaries in world coordinates as specified. More... | |
void | SetBoundaries (Coords_t lower, Coords_t upper) |
Sets the boundaries in world coordinates as specified. More... | |
void | ExtendToInclude (Coord_t x, Coord_t y, Coord_t z) |
Extends the current box to also include the specified point. More... | |
void | ExtendToInclude (geo::Point_t const &point) |
Extends the current box to also include the specified point. More... | |
void | ExtendToInclude (BoxBoundedGeo const &box) |
Extends the current box to also include the specified one. More... | |
std::vector< TVector3 > | GetIntersections (TVector3 const &TrajectoryStart, TVector3 const &TrajectoryDirect) const |
Calculates the entry and exit points of a trajectory on the box surface. More... | |
std::vector< geo::Point_t > | GetIntersections (geo::Point_t const &TrajectoryStart, geo::Vector_t const &TrajectoryDirect) const |
Calculates the entry and exit points of a trajectory on the box surface. More... | |
Static Public Member Functions | |
static bool | CoordinateContained (double c, double min, double max, double wiggle=1.) |
Returns whether the specified coordinate is in a range. More... | |
static bool | CoordinateContained (double c, double const *range, double wiggle=1.) |
static void | set_min (Coord_t &var, Coord_t value) |
Sets var to value if value is smaller than the current var value. More... | |
static void | set_min (Coords_t &var, geo::Point_t const &value) |
Sets each coordinate of var to the one in value if the latter is smaller. More... | |
static void | set_max (Coord_t &var, Coord_t value) |
Sets var to value if value is larger than the current var value. More... | |
static void | set_max (Coords_t &var, geo::Point_t const &value) |
Sets each coordinate of var to the one in value if the latter is larger. More... | |
Static Public Attributes | |
static constexpr unsigned int | MaxVerbosity = 6 |
Maximum verbosity supported by PrintTPCInfo() . More... | |
Private Types | |
using | DefaultVector_t = TVector3 |
using | DefaultPoint_t = TVector3 |
using | LocalTransformation_t = geo::LocalTransformationGeo< TGeoHMatrix, LocalPoint_t, LocalVector_t > |
Private Member Functions | |
void | FindPlane (GeoNodePath_t &path, size_t depth) |
void | MakePlane (GeoNodePath_t &path, size_t depth) |
void | ResetDriftDirection () |
Recomputes the drift direction; needs planes to have been initialised. More... | |
double | ComputeDriftDistance () const |
void | UpdatePlaneViewCache () |
Refills the plane vs. view cache of the TPC. More... | |
void | InitTPCBoundaries () |
Recomputes the TPC boundary. More... | |
void | SortPlanes (std::vector< geo::PlaneGeo > &) const |
Sorts (in place) the specified PlaneGeo objects by drift distance. More... | |
geo::Point_t | GetFrontFaceCenterImpl () const |
geo::Point_t | GetCathodeCenterImpl () const |
Private Attributes | |
LocalTransformation_t | fTrans |
TPC-to-world transformation. More... | |
std::vector< PlaneGeo > | fPlanes |
List of planes in this plane. More... | |
TGeoVolume * | fActiveVolume |
Active volume of LAr, called volTPCActive in GDML file. More... | |
TGeoVolume * | fTotalVolume |
Total volume of TPC, called volTPC in GDML file. More... | |
DriftDirection_t | fDriftDirection |
Direction of the electron drift in the TPC. More... | |
std::vector< double > | fPlane0Pitch |
Pitch between planes. More... | |
std::vector< std::vector< double > > | fPlaneLocation |
xyz locations of planes in the TPC. More... | |
geo::Point_t | fActiveCenter |
Center of the active volume, in world coordinates [cm]. More... | |
double | fActiveHalfWidth |
Half width of active volume. More... | |
double | fActiveHalfHeight |
Half height of active volume. More... | |
double | fActiveLength |
Length of active volume. More... | |
double | fHalfWidth |
Half width of total volume. More... | |
double | fHalfHeight |
Half height of total volume. More... | |
double | fLength |
Length of total volume. More... | |
geo::Vector_t | fWidthDir |
Direction width refers to. More... | |
geo::Vector_t | fHeightDir |
Direction height refers to. More... | |
geo::Vector_t | fLengthDir |
Direction length refers to. More... | |
geo::Vector_t | fDriftDir |
Direction electrons drift along. More... | |
geo::BoxBoundedGeo | fActiveBox |
Box of the active volume. More... | |
geo::TPCID | fID |
ID of this TPC. More... | |
std::vector< geo::PlaneID::PlaneID_t > | fViewToPlaneNumber |
Index of the plane for each view (InvalidID if none). More... | |
|
inherited |
Type of the coordinate.
Definition at line 38 of file BoxBoundedGeo.h.
|
inherited |
Type of the coordinate triplet.
Definition at line 37 of file BoxBoundedGeo.h.
|
private |
|
private |
|
private |
geo::TPCGeo::TPCGeo | ( | GeoNodePath_t & | path, |
size_t | depth | ||
) |
Definition at line 38 of file TPCGeo.cxx.
References fActiveCenter, fActiveHalfHeight, fActiveHalfWidth, fActiveLength, fActiveVolume, fHalfHeight, fHalfWidth, fHeightDir, FindPlane(), fLength, fLengthDir, fTotalVolume, fTrans, fWidthDir, InitTPCBoundaries(), LOG_DEBUG, geo::LocalTransformation< StoredMatrix >::Matrix(), ResetDriftDirection(), geo::Xaxis(), geo::Yaxis(), and geo::Zaxis().
|
inline |
Returns the box of the active volume of this TPC.
Definition at line 266 of file TPCGeo.h.
References fActiveBox, Plane0Pitch(), PlaneLocation(), PlanePitch(), and WirePitch().
Referenced by GetFrontFaceCenterImpl(), and PrintTPCInfo().
|
inline |
Half height (associated with y coordinate) of active TPC volume [cm].
Definition at line 91 of file TPCGeo.h.
References fActiveHalfHeight.
Referenced by ActiveHeight(), geo::GeometryCore::DetHalfHeight(), evd_tool::StandardDrawer::DrawActiveTPCoutline(), GetCathodeCenterImpl(), InitTPCBoundaries(), and evd::SimulationDrawer::SimulationDrawer().
|
inline |
Length (associated with z coordinate) of active TPC volume [cm].
Definition at line 97 of file TPCGeo.h.
References fActiveLength.
Referenced by evd_tool::StandardDrawer::DrawActiveTPCoutline(), and InitTPCBoundaries().
|
inline |
Half width (associated with x coordinate) of active TPC volume [cm].
Definition at line 87 of file TPCGeo.h.
References fActiveHalfWidth.
Referenced by ActiveWidth(), geo::GeometryCore::DetHalfWidth(), evd_tool::StandardDrawer::DrawActiveTPCoutline(), GetCathodeCenterImpl(), InitTPCBoundaries(), and evd::SimulationDrawer::SimulationDrawer().
|
inline |
Height (associated with y coordinate) of active TPC volume [cm].
Definition at line 93 of file TPCGeo.h.
References ActiveHalfHeight().
Referenced by PrintTPCInfo().
|
inline |
Length (associated with z coordinate) of active TPC volume [cm].
Definition at line 95 of file TPCGeo.h.
References fActiveLength.
Referenced by geo::GeometryCore::DetLength(), GetCathodeCenterImpl(), PrintTPCInfo(), and evd::SimulationDrawer::SimulationDrawer().
|
inline |
Half width (associated with x coordinate) of active TPC volume [cm].
Definition at line 110 of file TPCGeo.h.
References fActiveVolume.
Referenced by evgen::ActiveVolumeVertexSampler::reconfigure().
|
inline |
Half width (associated with x coordinate) of active TPC volume [cm].
Definition at line 111 of file TPCGeo.h.
References fActiveVolume.
|
inline |
Width (associated with x coordinate) of active TPC volume [cm].
Definition at line 89 of file TPCGeo.h.
References ActiveHalfWidth().
Referenced by PrintTPCInfo().
|
inline |
Returns the bounding box of this TPC.
Definition at line 262 of file TPCGeo.h.
Referenced by PrintTPCInfo().
|
inlineinherited |
Returns the center point of the box.
Definition at line 141 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::CenterX(), geo::BoxBoundedGeo::CenterY(), and geo::BoxBoundedGeo::CenterZ().
Referenced by geo::buildDriftVolumes(), geo::CryostatGeo::GetCenter(), and geo::PlaneGeo::UpdatePlaneNormal().
|
inlineinherited |
Returns the world x coordinate of the center of the box.
Definition at line 96 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::MaxX(), and geo::BoxBoundedGeo::MinX().
Referenced by geo::BoxBoundedGeo::Center().
|
inlineinherited |
Returns the world y coordinate of the center of the box.
Definition at line 111 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::MaxY(), and geo::BoxBoundedGeo::MinY().
Referenced by geo::BoxBoundedGeo::Center().
|
inlineinherited |
Returns the world z coordinate of the center of the box.
Definition at line 126 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::MaxZ(), and geo::BoxBoundedGeo::MinZ().
Referenced by geo::BoxBoundedGeo::Center().
|
inline |
Returns the 3D vector from composition of projection and distance.
Point | type of point to be returned |
decomp | decomposed point |
This is the "inverse" operation respect to DecomposePoint()
. The argument stores the two components, orthogonal and parallel to the plane, and compose them into a 3D point which departs from the reference point (ProjectionReferencePoint()
) by those components. See ComposePoint(double, Projection_t const&)
for more details.
Definition at line 458 of file TPCGeo.h.
References geo::PlaneGeo::ComposePoint(), and ReferencePlane().
|
inline |
Returns the 3D point from composition of projection and distance.
Point | type of point to be returned |
distance | distance of the target point from the reference plane |
proj | projection of the target point on the reference plane |
The returned point is the reference point, translated by two 3D vectors:
PointProjection()
gives the input projectionThe choice of the projection reference point embodies the same convention used in PointProjection()
and DecomposePoint()
.
Definition at line 480 of file TPCGeo.h.
References geo::PlaneGeo::ComposePoint(), proj, and ReferencePlane().
|
private |
Computes the distance between the cathode and the last wire plane (last respect to the sorting order).
Definition at line 481 of file TPCGeo.cxx.
References geo::PlaneGeo::DistanceFromPlane(), fPlanes, and GetCathodeCenter().
Referenced by DriftDistance().
|
inlineinherited |
Returns whether this volume contains the specified point.
point | the point [cm] |
wiggle | expansion factor for the range |
If the wiggle is larger than 1, each size of the volume is expanded by the wiggle factor. If the wiggle is less than 1, each size is shrinked.
Definition at line 207 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::ContainsX(), and geo::BoxBoundedGeo::ContainsYZ().
Referenced by geo::BoxBoundedGeo::ContainsPosition(), geo::BoxBoundedGeo::ContainsYZ(), and geo::GeometryCore::MaterialName().
|
inherited |
Definition at line 18 of file BoxBoundedGeo.cxx.
References geo::BoxBoundedGeo::ContainsPosition(), and geo::vect::toPoint().
|
inherited |
Definition at line 23 of file BoxBoundedGeo.cxx.
References geo::vect::makePointFromCoords().
|
inlineinherited |
Returns whether this TPC contains the specified world x coordinate.
x | the absolute ("world") coordinate x |
wiggle | expansion factor for the range (see ContainsPosition()) |
Note that x is by definition the drift direction, and a reconstructed x typically depends on an assumption respect to the event time.
Definition at line 161 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::CoordinateContained(), geo::BoxBoundedGeo::MaxX(), and geo::BoxBoundedGeo::MinX().
Referenced by geo::BoxBoundedGeo::ContainsPosition().
|
inlineinherited |
Returns whether this TPC contains the specified world y coordinate.
y | the absolute ("world") coordinate y |
wiggle | expansion factor for the range (see ContainsPosition()) |
Definition at line 171 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::CoordinateContained(), geo::BoxBoundedGeo::MaxY(), and geo::BoxBoundedGeo::MinY().
Referenced by geo::BoxBoundedGeo::ContainsYZ().
|
inlineinherited |
Returns if TPC contains the specified world y and z coordinates.
y | the absolute ("world") coordinate y |
z | the absolute ("world") coordinate z |
wiggle | expansion factor for the range (see ContainsPosition()) |
Definition at line 192 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::ContainsPosition(), geo::BoxBoundedGeo::ContainsY(), and geo::BoxBoundedGeo::ContainsZ().
Referenced by geo::BoxBoundedGeo::ContainsPosition().
|
inlineinherited |
Returns whether this TPC contains the specified world z coordinate.
z | the absolute ("world") coordinate z |
wiggle | expansion factor for the range (see ContainsPosition()) |
Definition at line 181 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::CoordinateContained(), geo::BoxBoundedGeo::MaxZ(), and geo::BoxBoundedGeo::MinZ().
Referenced by geo::BoxBoundedGeo::ContainsYZ().
|
inlinestatic |
Returns whether the specified coordinate is in a range.
c | the coordinate |
min | lower boundary of the range |
max | upper boundary of the range |
wiggle | expansion factor for the range |
If the wiggle is larger than 1, the range is expanded by the wiggle factor. If the wiggle is less than 1, the range is shrinked.
Definition at line 610 of file TPCGeo.h.
Referenced by CoordinateContained().
|
inlinestatic |
Definition at line 617 of file TPCGeo.h.
References CoordinateContained(), FindPlane(), and MakePlane().
|
inline |
Decomposes a 3D point in two components.
point | the point to be decomposed |
The point is decomposed in:
The distance is from the reference plane (DistanceFromReferencePlane()
). The projection on the plane is obtained following the same convention as PointProjection()
.
Definition at line 384 of file TPCGeo.h.
References geo::PlaneGeo::DecomposePointWidthDepth(), and ReferencePlane().
Referenced by DecomposePoint().
|
inline |
Decomposes a 3D point in two components.
point | the point to be decomposed |
The point is decomposed in:
The distance is from the reference plane (DistanceFromReferencePlane()
). The projection on the plane is obtained following the same convention as PointProjection()
.
Definition at line 386 of file TPCGeo.h.
References DecomposePoint(), and geo::vect::toPoint().
short int geo::TPCGeo::DetectDriftDirection | ( | ) | const |
Returns the expected drift direction based on geometry.
The return value is coded as follow:
The current implementation is based on the assumption that electrons in the middle of TPC will drift toward the wire planes, and it "never fails".
Definition at line 182 of file TPCGeo.cxx.
References geo::PlaneGeo::GetBoxCenter(), GetCenter(), ID(), Nplanes(), and Plane().
Referenced by GetCathodeCenterImpl(), nnet::TrainingDataAlg::getProjection(), pma::PMAlgTracker::mergeCoLinear(), detsim::SimDriftElectrons::produce(), ResetDriftDirection(), and toLocalCoords().
|
inline |
Returns the distance of the specified point from reference plane.
point | a point in world coordinates [cm] |
The distance is defined positive if the point lies in the inner side with respect to the reference plane.
It should match the drift distance from that plane.
Definition at line 343 of file TPCGeo.h.
References geo::PlaneGeo::DistanceFromPlane(), and ReferencePlane().
Referenced by DistanceFromReferencePlane().
|
inline |
Returns the plane used for reference by projection methods.
Definition at line 345 of file TPCGeo.h.
References DistanceFromReferencePlane(), and geo::vect::toPoint().
Vector geo::TPCGeo::DriftDir | ( | ) | const |
Returns the direction of the drift (vector pointing toward the planes).
Definition at line 687 of file TPCGeo.h.
References fDriftDir.
Referenced by checkTPCcoords(), DriftDirection(), groupTPCsByDriftDir(), and UpdateAfterSorting().
|
inline |
Returns an enumerator value describing the drift direction.
Definition at line 127 of file TPCGeo.h.
References DriftDir(), and fDriftDirection.
Referenced by util::DetectorPropertiesServiceArgoNeuT::CalculateXTicksParams(), detinfo::DetectorPropertiesStandard::CalculateXTicksParams(), and larg4::LArVoxelReadout::DriftIonizationElectrons().
|
inline |
Drift distance is defined as the distance between the last anode plane and the opposite face of the TPC, in centimeters.
Definition at line 135 of file TPCGeo.h.
References ComputeDriftDistance(), fPlanes, and Nplanes().
Referenced by pma::PMAlgCosmicTagger::GetDimensions(), and PrintTPCInfo().
|
inline |
Shifts the position of an electron drifted by a distance.
position | _(modified)_ the position of the electron |
distance | drift distance to shift the electron by [cm] |
This operation is delegated to the reference plane (see geo::Plane::DriftPoint()
).
Definition at line 360 of file TPCGeo.h.
References geo::PlaneGeo::DriftPoint(), and ReferencePlane().
|
inline |
Shifts the position of an electron drifted by a distance.
position | _(modified)_ the position of the electron |
distance | drift distance to shift the electron by [cm] |
This operation is delegated to the reference plane (see geo::Plane::DriftPoint()
).
Definition at line 362 of file TPCGeo.h.
References geo::PlaneGeo::DriftPoint(), and ReferencePlane().
Extends the current box to also include the specified point.
x | x coordinate of the point to include |
y | y coordinate of the point to include |
z | z coordinate of the point to include |
Definition at line 392 of file BoxBoundedGeo.h.
Referenced by geo::PlaneGeo::BoundingBox(), evd_tool::StandardDrawer::DetOutline3D(), and lar::example::SpacePointIsolationAlg::fillAlgConfigFromGeometry().
|
inlineinherited |
Extends the current box to also include the specified point.
point | coordinates of the point to include |
Definition at line 399 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_max, geo::BoxBoundedGeo::c_min, geo::BoxBoundedGeo::set_max(), and geo::BoxBoundedGeo::set_min().
|
inlineinherited |
Extends the current box to also include the specified one.
box | the box to include |
It is assumed that the box has its boundaries properly sorted.
Definition at line 411 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_max, geo::BoxBoundedGeo::c_min, geo::BoxBoundedGeo::GetIntersections(), geo::BoxBoundedGeo::Max(), geo::BoxBoundedGeo::Min(), geo::BoxBoundedGeo::set_max(), and geo::BoxBoundedGeo::set_min().
|
private |
Definition at line 149 of file TPCGeo.cxx.
References MakePlane().
Referenced by CoordinateContained(), and TPCGeo().
|
inline |
Returns the first wire plane (the closest to TPC center).
Definition at line 225 of file TPCGeo.h.
References fPlanes.
Referenced by ReferencePlane().
|
inline |
Returns the center of the TPC active volume in world coordinates [cm].
Definition at line 247 of file TPCGeo.h.
References fActiveCenter.
Referenced by evd_tool::StandardDrawer::DrawActiveTPCoutline(), and evd::SimulationDrawer::SimulationDrawer().
|
inline |
Returns the center of the active volume face opposite to the wire planes [cm]
Definition at line 253 of file TPCGeo.h.
References GetCathodeCenterImpl().
Referenced by geo::DriftPartitions::computeCoverage(), and ComputeDriftDistance().
|
private |
Definition at line 361 of file TPCGeo.cxx.
References ActiveHalfHeight(), ActiveHalfWidth(), ActiveLength(), DetectDriftDirection(), and geo::vect::Xcoord().
Referenced by GetCathodeCenter().
Point geo::TPCGeo::GetCenter | ( | ) | const |
Returns the center of the TPC volume in world coordinates [cm].
Definition at line 693 of file TPCGeo.h.
References toWorldCoords().
Referenced by DetectDriftDirection(), evd_tool::ICARUSDrawer::DetOutline3D(), LastPlane(), ResetDriftDirection(), evd::SimulationDrawer::SimulationDrawer(), and SortPlanes().
Returns the plane in planeid from this TPC.
planeid | full plane ID |
cet::exception | (category "PlaneOutOfRange") if no such plane |
The cryostat and TPC numbers in planeid are ignored, as it is ignored whether planeid is invalid.
Definition at line 194 of file TPCGeo.h.
References Plane().
Returns the plane in planeid from this TPC.
planeid | full plane ID |
The cryostat and TPC numbers in planeid are ignored, as it is ignored whether planeid is invalid.
Definition at line 217 of file TPCGeo.h.
References PlanePtr(), and SmallestPlane().
|
inline |
Returns the center of the active TPC volume side facing negative z.
Definition at line 258 of file TPCGeo.h.
References GetFrontFaceCenterImpl().
|
private |
Definition at line 405 of file TPCGeo.cxx.
References ActiveBoundingBox().
Referenced by GetFrontFaceCenter().
|
inherited |
Calculates the entry and exit points of a trajectory on the box surface.
TrajectoryStart | position of the trajectory source |
TrajectoryDirect | direction vector of the trajectory |
This member is public since it just gives an output and does not change any member. The algorithm works only for a box shaped active volume with facing walls parallel to axis. If the return std::vector is empty the trajectory does not intersect with the box. Normally the return value should have one (if the trajectory originates in the box) or two (else) entries. If the return value has two entries the first represents the entry point and the second the exit point
Definition at line 118 of file BoxBoundedGeo.cxx.
Referenced by geo::BoxBoundedGeo::ExtendToInclude(), and geo::BoxBoundedGeo::GetIntersections().
|
inherited |
Calculates the entry and exit points of a trajectory on the box surface.
TrajectoryStart | position of the trajectory source |
TrajectoryDirect | direction vector of the trajectory |
This member is public since it just gives an output and does not change any member. The algorithm works only for a box shaped active volume with facing walls parallel to axis. If the return std::vector is empty the trajectory does not intersect with the box. Normally the return value should have one (if the trajectory originates in the box) or two (else) entries. If the return value has two entries the first represents the entry point and the second the exit point
Definition at line 27 of file BoxBoundedGeo.cxx.
References geo::vect::bindCoord(), geo::BoxBoundedGeo::c_max, geo::BoxBoundedGeo::c_min, geo::vect::coord(), geo::BoxBoundedGeo::GetIntersections(), geo::BoxBoundedGeo::Max(), and geo::BoxBoundedGeo::Min().
|
inline |
Height is associated with y coordinate [cm].
Definition at line 103 of file TPCGeo.h.
References fHalfHeight.
Referenced by evd_tool::ICARUSDrawer::DetOutline3D(), larg::LArSimChannelAna::ensureHists(), hit::MagDriftAna::ensureHists(), pma::PMAlgCosmicTagger::GetDimensions(), pma::PMAlgStitching::GetTPCXOffsets(), Height(), InitTPCBoundaries(), and evd::SimulationDrawer::SimulationDrawer().
|
inline |
Length is associated with z coordinate [cm].
Definition at line 109 of file TPCGeo.h.
References fLength.
Referenced by InitTPCBoundaries().
|
inlineinherited |
Returns the size from the center to the border on X dimension.
Definition at line 102 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::SizeX().
|
inlineinherited |
Returns the size from the center to the border on Y dimension.
Definition at line 117 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::SizeY().
|
inlineinherited |
Returns the size from the center to the border on Z dimension.
Definition at line 132 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::SizeZ().
|
inline |
Width is associated with x coordinate [cm].
Definition at line 99 of file TPCGeo.h.
References fHalfWidth.
Referenced by evd_tool::ICARUSDrawer::DetOutline3D(), larg::LArSimChannelAna::ensureHists(), hit::MagDriftAna::ensureHists(), pma::PMAlgCosmicTagger::GetDimensions(), pma::PMAlgStitching::GetTPCXOffsets(), InitTPCBoundaries(), evd::SimulationDrawer::SimulationDrawer(), and Width().
|
inline |
Returns whether a plane with index iplane is present in this TPC.
iplane | index of plane in this TPC |
Definition at line 156 of file TPCGeo.h.
References HasPlane().
|
inline |
Returns whether the plane in planeid is present in this TPC.
planeid | full plane ID |
The cryostat and TPC numbers in planeid are ignored, as it is ignored whether planeid is invalid.
Definition at line 170 of file TPCGeo.h.
References HasPlane(), and Plane().
|
inline |
Returns whether a plane with index iplane is present in this TPC.
iplane | index of plane in this TPC |
Definition at line 155 of file TPCGeo.h.
References Nplanes().
Referenced by pma::ProjectionMatchingAlg::buildShowerSeg(), pma::VtxCandidate::ComputeMse2D(), pma::PMAlgStitching::GetTPCXOffsets(), pma::ProjectionMatchingAlg::guideEndpoints(), HasElement(), HasPlane(), geo::GeometryCore::HasPlane(), pma::PMAlgTracker::matchCluster(), pma::Node3D::Node3D(), PlanePtr(), trkf::PMAlgTrajFitter::produce(), trkf::PMAlgTrackMaker::produce(), and pma::ProjectionMatchingAlg::TestTrk().
|
inline |
Returns whether the plane in planeid is present in this TPC.
planeid | full plane ID |
The cryostat and TPC numbers in planeid are ignored, as it is ignored whether planeid is invalid.
Definition at line 168 of file TPCGeo.h.
References HasPlane(), and geo::PlaneID::Plane.
|
inline |
Height is associated with y coordinate [cm].
Definition at line 105 of file TPCGeo.h.
References HalfHeight().
Referenced by PrintTPCInfo().
|
inline |
Returns the direction Height()
is measured on.
Definition at line 120 of file TPCGeo.h.
References fHeightDir.
|
inline |
Returns the identifier of this TPC.
Definition at line 278 of file TPCGeo.h.
References fID.
Referenced by checkTPCcoords(), DetectDriftDirection(), evd_tool::ICARUSDrawer::DetOutline3D(), geo::GeometryCore::PositionToTPC(), geo::CryostatGeo::PositionToTPCID(), geo::GeometryCore::PositionToTPCID(), and PrintTPCInfo().
|
inlineinherited |
Returns whether TPC fiducial volume contains world x coordinate.
x | the absolute ("world") coordinate x |
neg_margin | how far within the TPC the fiducial region starts |
pos_margin | how far before the TPC the fiducial region ends |
The fiducial volume is defined by the specified margins, that denote how much of the coordinate is not fiducial. For example,
bool bWithin = tpc->InFiducialX(x, 5., 8.);
on a TPC with x from 0 to 100 (cm, presumably) will return true for all x
between 5 and 92. If positive margin is not specified, it's assumed to be the same as the negative one. Specifying a negative mergin effectively extends the TPC volume. Note that x is by definition the drift direction, and a reconstructed x typically depends on an assumption respect to the event time.
Definition at line 243 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::CoordinateContained(), geo::BoxBoundedGeo::MaxX(), and geo::BoxBoundedGeo::MinX().
Referenced by geo::BoxBoundedGeo::InFiducialX().
|
inlineinherited |
Returns whether TPC fiducial volume contains world x coordinate.
Margins are symmetric.
Definition at line 253 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::InFiducialX().
|
inlineinherited |
Returns whether TPC fiducial volume contains world y coordinate.
y | the absolute ("world") coordinate y |
neg_margin | how far within the TPC the fiducial region starts |
pos_margin | how far before the TPC the fiducial region ends |
The fiducial volume is defined by the specified margins, that denote how much of the coordinate is not fiducial. For example,
bool bWithin = tpc->InFiducialY(y, 5., 8.);
on a TPC with y from 0 to 100 (cm, presumably) will return true for all y
between 5 and 92. If positive margin is not specified, it's assumed to be the same as the negative one. Specifying a negative mergin effectively extends the TPC volume.
Definition at line 274 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::CoordinateContained(), geo::BoxBoundedGeo::MaxY(), and geo::BoxBoundedGeo::MinY().
Referenced by geo::BoxBoundedGeo::InFiducialY().
|
inlineinherited |
Returns whether TPC fiducial volume contains world y coordinate.
Margins are symmetric.
Definition at line 284 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::InFiducialY().
|
inlineinherited |
Returns whether TPC fiducial volume contains world z coordinate.
z | the absolute ("world") coordinate y |
neg_margin | how far within the TPC the fiducial region starts |
pos_margin | how far before the TPC the fiducial region ends |
The fiducial volume is defined by the specified margins, that denote how much of the coordinate is not fiducial. For example,
bool bWithin = tpc->InFiducialZ(z, 5., 8.);
on a TPC with z from 0 to 100 (cm, presumably) will return true for all z
between 5 and 92. If positive margin is not specified, it's assumed to be the same as the negative one. Specifying a negative mergin effectively extends the TPC volume.
Definition at line 305 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::CoordinateContained(), geo::BoxBoundedGeo::MaxZ(), and geo::BoxBoundedGeo::MinZ().
Referenced by geo::BoxBoundedGeo::InFiducialZ().
|
inlineinherited |
Returns whether TPC fiducial volume contains world z coordinate.
Margins are symmetric.
Definition at line 315 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::CoordinateContained(), and geo::BoxBoundedGeo::InFiducialZ().
|
private |
Recomputes the TPC boundary.
Definition at line 495 of file TPCGeo.cxx.
References ActiveHalfHeight(), ActiveHalfLength(), ActiveHalfWidth(), fActiveBox, HalfHeight(), HalfLength(), HalfWidth(), geo::BoxBoundedGeo::SetBoundaries(), and toWorldCoords().
Referenced by TPCGeo().
|
inline |
Returns the last wire plane (the farther from TPC center).
Definition at line 228 of file TPCGeo.h.
References fPlanes, GetCenter(), MaxWires(), Nplanes(), and Views().
Referenced by geo::DriftPartitions::computeCoverage().
|
inline |
Length is associated with z coordinate [cm].
Definition at line 107 of file TPCGeo.h.
References fLength.
Referenced by evd_tool::ICARUSDrawer::DetOutline3D(), larg::LArSimChannelAna::ensureHists(), hit::MagDriftAna::ensureHists(), pma::PMAlgCosmicTagger::GetDimensions(), pma::PMAlgStitching::GetTPCXOffsets(), PrintTPCInfo(), evd::SimulationDrawer::SimulationDrawer(), and apa::APAGeometryAlg::ThreeChanPos().
|
inline |
Returns the direction Length()
is measured on.
Definition at line 124 of file TPCGeo.h.
References fLengthDir.
|
inline |
Transform point from local TPC frame to world frame.
Definition at line 490 of file TPCGeo.h.
References fTrans, and geo::LocalTransformation< StoredMatrix >::LocalToWorld().
Referenced by DUNE::NeutrinoShowerEff::beginJob(), DUNE::NeutrinoTrackingEff::beginJob(), DUNE::MuonTrackingEff::beginJob(), NuShowerEff::beginJob(), tca::FillWireHitRange(), cluster::ClusterCrawlerAlg::FindHammerClusters(), pma::PMAlgCosmicTagger::GetDimensions(), pma::PMAlgStitching::GetTPCXOffsets(), tca::InsideTPC(), evd::RecoBaseDrawer::OpFlashOrtho(), evd::Ortho3DPad::Ortho3DPad(), evgen::NDKGen::produce(), geo::sortTPCStandard(), trkf::CCTrackMaker::TagCosmics(), apa::DisambigAlg::TrivialDisambig(), apa::DisambigAlg::UseEndPts(), evd::RecoBaseDrawer::Vertex2D(), and cluster::ClusterCrawlerAlg::VtxMatch().
|
inline |
Transform point from local TPC frame to world frame.
Definition at line 494 of file TPCGeo.h.
References fTrans, and geo::LocalTransformation< StoredMatrix >::LocalToWorld().
|
inline |
Transform direction vector from local to world.
Definition at line 502 of file TPCGeo.h.
References fTrans, and geo::LocalTransformation< StoredMatrix >::LocalToWorldVect().
|
inline |
Transform direction vector from local to world.
Definition at line 506 of file TPCGeo.h.
References fTrans, and geo::LocalTransformation< StoredMatrix >::LocalToWorldVect().
|
private |
Definition at line 175 of file TPCGeo.cxx.
References fPlanes.
Referenced by CoordinateContained(), and FindPlane().
|
inlineinherited |
Returns the corner point with the largest coordinates.
Definition at line 138 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_max.
Referenced by geo::BoxBoundedGeo::ExtendToInclude(), geo::BoxBoundedGeo::GetIntersections(), geo::GeometryCore::MaterialName(), geo::CryostatGeo::PrintCryostatInfo(), and PrintTPCInfo().
unsigned int geo::TPCGeo::MaxWires | ( | ) | const |
Returns the largest number of wires among the planes in this TPC.
Definition at line 333 of file TPCGeo.cxx.
References fPlanes.
Referenced by LastPlane(), geo::CryostatGeo::MaxWires(), and PrintTPCInfo().
|
inlineinherited |
Returns the world x coordinate of the end of the box.
Definition at line 93 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_max.
Referenced by geo::CryostatGeo::Boundaries(), geo::BoxBoundedGeo::CenterX(), geo::BoxBoundedGeo::ContainsX(), evd_tool::ICARUSDrawer::DetOutline3D(), evd_tool::StandardDrawer::DrawBoxBoundedGeoOutline(), lar::example::SpacePointIsolationAlg::fillAlgConfigFromGeometry(), mvapid::MVAAlg::GetDetectorEdges(), geo::BoxBoundedGeo::InFiducialX(), evd::SimulationDrawer::MCTruthOrtho(), evgen::NucleonDecay::produce(), evgen::NeutronOsc::produce(), geo::BoxBoundedGeo::SizeX(), TPCarea(), and geo::GeometryCore::WorldBox().
|
inlineinherited |
Returns the world y coordinate of the end of the box.
Definition at line 108 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_max.
Referenced by geo::CryostatGeo::Boundaries(), geo::BoxBoundedGeo::CenterY(), geo::BoxBoundedGeo::ContainsY(), evd_tool::ICARUSDrawer::DetOutline3D(), evd_tool::StandardDrawer::DrawBoxBoundedGeoOutline(), lar::example::SpacePointIsolationAlg::fillAlgConfigFromGeometry(), mvapid::MVAAlg::GetDetectorEdges(), geo::BoxBoundedGeo::InFiducialY(), pma::Node3D::Node3D(), evgen::NucleonDecay::produce(), evgen::NeutronOsc::produce(), tca::SaveCRInfo(), geo::BoxBoundedGeo::SizeY(), TPCarea(), and geo::GeometryCore::WorldBox().
|
inlineinherited |
Returns the world z coordinate of the end of the box.
Definition at line 123 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_max.
Referenced by geo::CryostatGeo::Boundaries(), geo::BoxBoundedGeo::CenterZ(), geo::BoxBoundedGeo::ContainsZ(), evd_tool::ICARUSDrawer::DetOutline3D(), evd_tool::StandardDrawer::DrawBoxBoundedGeoOutline(), lar::example::SpacePointIsolationAlg::fillAlgConfigFromGeometry(), mvapid::MVAAlg::GetDetectorEdges(), geo::BoxBoundedGeo::InFiducialZ(), pma::Node3D::Node3D(), evgen::NucleonDecay::produce(), evgen::NeutronOsc::produce(), tca::SaveCRInfo(), geo::BoxBoundedGeo::SizeZ(), TPCarea(), and geo::GeometryCore::WorldBox().
|
inlineinherited |
Returns the corner point with the smallest coordinates.
Definition at line 135 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_min.
Referenced by geo::BoxBoundedGeo::ExtendToInclude(), geo::BoxBoundedGeo::GetIntersections(), geo::GeometryCore::MaterialName(), geo::CryostatGeo::PrintCryostatInfo(), and PrintTPCInfo().
|
inlineinherited |
Returns the world x coordinate of the start of the box.
Definition at line 90 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_min.
Referenced by geo::CryostatGeo::Boundaries(), geo::BoxBoundedGeo::CenterX(), geo::BoxBoundedGeo::ContainsX(), evd_tool::ICARUSDrawer::DetOutline3D(), evd_tool::StandardDrawer::DrawBoxBoundedGeoOutline(), lar::example::SpacePointIsolationAlg::fillAlgConfigFromGeometry(), mvapid::MVAAlg::GetDetectorEdges(), geo::BoxBoundedGeo::InFiducialX(), pma::Track3D::InitFromMiddle(), evd::SimulationDrawer::MCTruthOrtho(), evgen::NucleonDecay::produce(), evgen::NeutronOsc::produce(), evgen::ActiveVolumeVertexSampler::sample_vertex_pos(), geo::BoxBoundedGeo::SizeX(), TPCarea(), and geo::GeometryCore::WorldBox().
|
inlineinherited |
Returns the world y coordinate of the start of the box.
Definition at line 105 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_min.
Referenced by geo::CryostatGeo::Boundaries(), geo::BoxBoundedGeo::CenterY(), geo::BoxBoundedGeo::ContainsY(), evd_tool::ICARUSDrawer::DetOutline3D(), evd_tool::StandardDrawer::DrawBoxBoundedGeoOutline(), lar::example::SpacePointIsolationAlg::fillAlgConfigFromGeometry(), mvapid::MVAAlg::GetDetectorEdges(), geo::BoxBoundedGeo::InFiducialY(), pma::Node3D::Node3D(), evgen::NucleonDecay::produce(), evgen::NeutronOsc::produce(), tca::SaveCRInfo(), geo::BoxBoundedGeo::SizeY(), TPCarea(), and geo::GeometryCore::WorldBox().
|
inlineinherited |
Returns the world z coordinate of the start of the box.
Definition at line 120 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_min.
Referenced by geo::CryostatGeo::Boundaries(), geo::BoxBoundedGeo::CenterZ(), geo::BoxBoundedGeo::ContainsZ(), evd_tool::ICARUSDrawer::DetOutline3D(), evd_tool::StandardDrawer::DrawBoxBoundedGeoOutline(), lar::example::SpacePointIsolationAlg::fillAlgConfigFromGeometry(), mvapid::MVAAlg::GetDetectorEdges(), geo::BoxBoundedGeo::InFiducialZ(), pma::Node3D::Node3D(), evgen::NucleonDecay::produce(), evgen::NeutronOsc::produce(), tca::SaveCRInfo(), geo::BoxBoundedGeo::SizeZ(), TPCarea(), and geo::GeometryCore::WorldBox().
|
inline |
Number of planes in this tpc.
Definition at line 146 of file TPCGeo.h.
References fPlanes.
Referenced by geo::GeometryCore::Nplanes().
|
inline |
Number of planes in this tpc.
Definition at line 145 of file TPCGeo.h.
Referenced by trkf::SpacePointAna::bookHistograms(), calo::LinearEnergyAlg::CalculateEnergy(), util::DetectorPropertiesServiceArgoNeuT::CalculateXTicksParams(), detinfo::DetectorPropertiesStandard::CalculateXTicksParams(), DetectDriftDirection(), hit::DisambigCheater::DisambigCheater(), DriftDistance(), larg4::LArVoxelReadout::DriftIonizationElectrons(), trkf::SpacePointAlg::fillComplexSpacePoint(), vertex::FeatureVertexFinder::Find2dClusterVertexCandidates(), tca::FindShowers3D(), trkf::BezierTrack::GetProjectedPointUVWT(), trkf::BezierTrack::GetProjectedPointUVWX(), trkf::BezierTrack::GetTrackPitch(), groupByDriftCoordinate(), HasPlane(), geo::ChannelMapStandardAlg::Initialize(), LastPlane(), trkf::SpacePointAlg::makeSpacePoints(), geo::CryostatGeo::MaxPlanes(), tca::MergePFPTjs(), geo::GeometryCore::Print(), PrintTPCInfo(), detsim::SimDriftElectrons::produce(), vertex::FeatureVertexFinder::produce(), cluster::ClusterCrawlerAlg::RunCrawler(), SortSubVolumes(), trkf::CosmicTrackerAlg::TrackTrajectory(), trkf::SpacePointAlg::update(), UpdateAfterSorting(), UpdatePlaneViewCache(), pma::Node3D::UpdateProj2D(), trkf::VertexFitAlg::VertexFit(), cluster::ClusterCrawlerAlg::VtxMatch(), and geo::GeometryCore::WireAngleToVertical().
const PlaneGeo & geo::TPCGeo::Plane | ( | geo::View_t | view | ) | const |
Return the plane in the tpc with View_t view.
Definition at line 299 of file TPCGeo.cxx.
References fPlanes, fViewToPlaneNumber, and geo::PlaneID::InvalidID.
Referenced by hit::MagDriftAna::analyze(), trkf::SpacePointAna::bookHistograms(), util::DetectorPropertiesServiceArgoNeuT::CalculateXTicksParams(), detinfo::DetectorPropertiesStandard::CalculateXTicksParams(), evd::RecoBaseDrawer::Cluster2D(), pma::CmToWireDrift(), lar_pandora::LArPandoraInput::CreatePandoraHits2D(), lar_pandora::LArPandoraInput::CreatePandoraReadoutGaps(), DetectDriftDirection(), hit::DisambigCheater::DisambigCheater(), evd::RecoBaseDrawer::DrawTrack2D(), evd::RecoBaseDrawer::DrawTrackVertexAssns2D(), larg4::LArVoxelReadout::DriftIonizationElectrons(), cluster::EndPointAlg::EndPoint(), evd::RecoBaseDrawer::EndPoint2D(), evd::RecoBaseDrawer::Event2D(), cluster::HoughBaseAlg::FastTransform(), corner::CornerFinderAlg::get_feature_points_fast(), pma::ProjectionMatchingAlg::GetCloseHits(), GetElement(), pma::GetProjectionToPlane(), trkf::BezierTrack::GetTrackPitch(), lar_pandora::PFParticleHitDumper::GetUVW(), HasElement(), geo::ChannelMapStandardAlg::Initialize(), lar_pandora::LArPandoraGeometry::LoadGeometry(), trkf::SpacePointAlg::makeSpacePoints(), Plane(), geo::GeometryCore::Print(), lar_pandora::LArPandoraTrackCreation::produce(), cluster::ClusterCheater::produce(), vertex::HarrisVertexFinder::produce(), evd::RecoBaseDrawer::Prong2D(), evd::RecoBaseDrawer::RecoBaseDrawer(), ResetDriftDirection(), geo::GeometryCore::ThirdPlane_dTdW(), geo::GeometryCore::ThirdPlaneSlope(), cluster::HoughBaseAlg::Transform(), trkf::SpacePointAlg::update(), pma::Node3D::UpdateProj2D(), pma::ProjectionMatchingAlg::validate(), pma::ProjectionMatchingAlg::validate_on_adc_test(), geo::GeometryCore::WireAngleToVertical(), pma::WireDriftToCm(), and WirePitch().
const PlaneGeo & geo::TPCGeo::Plane | ( | unsigned int | iplane | ) | const |
Return the iplane'th plane in the TPC.
cet::exception | (category "PlaneOutOfRange") if no such plane |
Definition at line 288 of file TPCGeo.cxx.
References PlanePtr().
Returns the plane in planeid from this TPC.
planeid | full plane ID |
cet::exception | (category "PlaneOutOfRange") if no such plane |
The cryostat and TPC numbers in planeid are ignored, as it is ignored whether planeid is invalid.
Definition at line 192 of file TPCGeo.h.
References Plane(), and geo::PlaneID::Plane.
double geo::TPCGeo::Plane0Pitch | ( | unsigned int | p | ) | const |
Returns the center of the TPC volume in world coordinates [cm].
Definition at line 355 of file TPCGeo.cxx.
References fPlane0Pitch.
Referenced by ActiveBoundingBox(), larg4::LArVoxelReadout::DriftIonizationElectrons(), groupByDriftCoordinate(), and trkf::SpacePointAlg::update().
const double * geo::TPCGeo::PlaneLocation | ( | unsigned int | p | ) | const |
Returns the coordinates of the center of the specified plane [cm].
Definition at line 413 of file TPCGeo.cxx.
References fPlaneLocation.
Referenced by ActiveBoundingBox(), util::DetectorPropertiesServiceArgoNeuT::CalculateXTicksParams(), detinfo::DetectorPropertiesStandard::CalculateXTicksParams(), larg4::LArVoxelReadout::DriftIonizationElectrons(), pma::PMAlgStitching::GetTPCXOffsets(), detsim::SimDriftElectrons::produce(), DUNE::NeutrinoTrackingEff::truthLength(), and trkf::SpacePointAlg::update().
double geo::TPCGeo::PlanePitch | ( | unsigned int | p1 = 0 , |
unsigned int | p2 = 1 |
||
) | const |
Returns the center of the TPC volume in world coordinates [cm].
Definition at line 419 of file TPCGeo.cxx.
References fPlane0Pitch.
Referenced by ActiveBoundingBox(), util::DetectorPropertiesServiceArgoNeuT::CalculateXTicksParams(), detinfo::DetectorPropertiesStandard::CalculateXTicksParams(), larg4::LArVoxelReadout::DriftIonizationElectrons(), geo::GeometryCore::PlanePitch(), and detsim::SimDriftElectrons::produce().
|
inline |
Returns the plane number iplane from this TPC.
iplane | the number of local plane |
Definition at line 203 of file TPCGeo.h.
References fPlanes, and HasPlane().
Referenced by GetElementPtr(), Plane(), PlanePtr(), and geo::GeometryCore::PlanePtr().
Returns the plane in planeid from this TPC.
planeid | full plane ID |
The cryostat and TPC numbers in planeid are ignored, as it is ignored whether planeid is invalid.
Definition at line 215 of file TPCGeo.h.
References geo::PlaneID::Plane, and PlanePtr().
|
inline |
Returns the projection of the specified point on the plane.
point | the 3D point to be projected, in world coordinates |
The returned vector is a 2D vector expressing the projection of the point (from world coordinates) on the reference plane. The vector is expressed as , components following the width direction (RefWidthDir()
) and the depth direction (RefDepthDir()
) respectively. The origin point is returned by ProjectionReferencePoint()
. All coordinates are in centimeters.
Definition at line 417 of file TPCGeo.h.
References Projection().
|
inline |
Returns the projection of the specified point on the plane.
point | the 3D point to be projected, in world coordinates |
The returned vector is a 2D vector expressing the projection of the point (from world coordinates) on the reference plane. The vector is expressed as , components following the width direction (RefWidthDir()
) and the depth direction (RefDepthDir()
) respectively. The origin point is returned by ProjectionReferencePoint()
. All coordinates are in centimeters.
Definition at line 419 of file TPCGeo.h.
References Projection(), and geo::vect::toPoint().
void geo::TPCGeo::PrintTPCInfo | ( | Stream && | out, |
std::string | indent = "" , |
||
unsigned int | verbosity = 1 |
||
) | const |
Prints information about this TPC.
Stream | type of output stream to use |
out | stream to send the information to |
indent | prepend each line with this string |
verbosity | amount of information printed |
Note that the first line out the output is not indented.
The constant MaxVerbosity
is set to the highest supported verbosity level.
Definition at line 703 of file TPCGeo.h.
References ActiveBoundingBox(), ActiveHeight(), ActiveLength(), ActiveWidth(), BoundingBox(), DriftDistance(), Height(), ID(), Length(), geo::BoxBoundedGeo::Max(), MaxWires(), geo::BoxBoundedGeo::Min(), Nplanes(), and Width().
Referenced by geo::part::PartitionDataDescriber< geo::TPCGeo >::PartitionDataDescriber(), geo::GeometryCore::Print(), and toLocalCoords().
|
inline |
Returns the projection of the specified point on the plane.
point | the 3D point to be projected, in world coordinates |
The returned vector is a 2D vector expressing the projection of the point (from world coordinates) on the reference plane. The vector is expressed as , components following the width direction (RefWidthDir()
) and the depth direction (RefDepthDir()
) respectively. The origin point is returned by ProjectionReferencePoint()
. All coordinates are in centimeters.
Definition at line 415 of file TPCGeo.h.
References geo::PlaneGeo::PointWidthDepthProjection(), and ReferencePlane().
Referenced by PointProjection(), and VectorProjection().
|
inline |
Returns the projection of the specified vector on the plane.
v | the 3D vector to be projected, in world units [cm] |
The returned vector is a 2D vector expressing the projection of the vector (from world units) on the reference plane. The vector is expressed as , components following the width direction (RefWidthDir()
) and the depth direction (RefDepthDir()
) respectively. All coordinates are in centimeters.
Definition at line 436 of file TPCGeo.h.
References ReferencePlane(), and geo::PlaneGeo::VectorWidthDepthProjection().
|
inline |
Returns the reference point used by PointProjection()
.
Point | type of point to be returned |
The returned point is such that its decomposition results in a null projection and a 0 distance from the plane.
Definition at line 398 of file TPCGeo.h.
References geo::PlaneGeo::GetCenter(), and ReferencePlane().
|
inline |
Return the direction of reference plane depth.
Vector | type of vector to return (current default: TVector3 ) |
The precise definition of the vector is arbitrary, but it is defined to lie on the wire plane and so that RefWidthDir(), RefDepthDir() and a vector opposite to DriftDir() make a orthonormal base. That base (width, depth, normal) is guaranteed to be positive defined.
Definition at line 329 of file TPCGeo.h.
References geo::PlaneGeo::DepthDir(), and ReferencePlane().
Referenced by geo::buildDriftVolumes().
|
inline |
Returns the plane used for reference by projection methods.
Definition at line 299 of file TPCGeo.h.
References FirstPlane().
Referenced by ComposePoint(), DecomposePoint(), DistanceFromReferencePlane(), DriftPoint(), Projection(), ProjectionReferencePoint(), RefDepthDir(), ReferencePlaneID(), and RefWidthDir().
|
inline |
Returns the ID of the plane used for reference by projection methods.
Definition at line 302 of file TPCGeo.h.
References geo::PlaneGeo::ID(), and ReferencePlane().
|
inline |
Return the direction of reference plane width.
Vector | type of vector to return (current default: TVector3 ) |
The precise definition of the vector is arbitrary, but it is defined to lie on the wire plane and so that RefWidthDir(), RefDepthDir() and a vector opposite to DriftDir() make a orthonormal base. That base (width, depth, normal) is guaranteed to be positive defined.
Definition at line 316 of file TPCGeo.h.
References ReferencePlane(), and geo::PlaneGeo::WidthDir().
Referenced by geo::buildDriftVolumes().
|
private |
Recomputes the drift direction; needs planes to have been initialised.
Definition at line 433 of file TPCGeo.cxx.
References DetectDriftDirection(), e, fDriftDir, fDriftDirection, geo::PlaneGeo::GetBoxCenter(), GetCenter(), geo::kNeg, geo::kNegX, geo::kPos, geo::kPosX, geo::kUnknownDrift, Plane(), geo::vect::round01(), geo::Xaxis(), geo::Yaxis(), and geo::Zaxis().
Referenced by TPCGeo().
Sets var to value if value is larger than the current var value.
Definition at line 446 of file BoxBoundedGeo.h.
References fhicl::detail::atom::value().
Referenced by geo::BoxBoundedGeo::ExtendToInclude().
|
inlinestaticinherited |
Sets each coordinate of var to the one in value if the latter is larger.
Definition at line 458 of file BoxBoundedGeo.h.
Sets var to value if value is smaller than the current var value.
Definition at line 442 of file BoxBoundedGeo.h.
References fhicl::detail::atom::value().
Referenced by geo::BoxBoundedGeo::ExtendToInclude().
|
inlinestaticinherited |
Sets each coordinate of var to the one in value if the latter is smaller.
Definition at line 450 of file BoxBoundedGeo.h.
|
inlineinherited |
Sets the boundaries in world coordinates as specified.
x_min | lower x coordinate |
x_max | upper x coordinate |
y_min | lower y coordinate |
y_max | upper y coordinate |
z_min | lower z coordinate |
z_max | upper z coordinate |
Definition at line 367 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_max, geo::BoxBoundedGeo::c_min, and geo::BoxBoundedGeo::SortCoordinates().
Referenced by geo::PlaneGeo::BoundingBox(), geo::CryostatGeo::InitCryoBoundaries(), and InitTPCBoundaries().
Sets the boundaries in world coordinates as specified.
lower | lower coordinates (x, y, z) |
upper | upper coordinates (x, y, z) |
Definition at line 383 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::c_max, geo::BoxBoundedGeo::c_min, and geo::BoxBoundedGeo::SortCoordinates().
|
inlineinherited |
Returns the full size in the X dimension.
Definition at line 99 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::MaxX(), and geo::BoxBoundedGeo::MinX().
Referenced by geo::BoxBoundedGeo::HalfSizeX().
|
inlineinherited |
Returns the full size in the Y dimension.
Definition at line 114 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::MaxY(), and geo::BoxBoundedGeo::MinY().
Referenced by geo::BoxBoundedGeo::HalfSizeY().
|
inlineinherited |
Returns the full size in the Z dimension.
Definition at line 129 of file BoxBoundedGeo.h.
References geo::BoxBoundedGeo::MaxZ(), and geo::BoxBoundedGeo::MinZ().
Referenced by geo::BoxBoundedGeo::HalfSizeZ().
geo::PlaneGeo const & geo::TPCGeo::SmallestPlane | ( | ) | const |
Returns the wire plane with the smallest surface.
Definition at line 312 of file TPCGeo.cxx.
References fPlanes.
Referenced by GetElementPtr().
|
private |
Sorts (in place) the specified PlaneGeo
objects by drift distance.
Definition at line 536 of file TPCGeo.cxx.
References geo::vect::dot(), GetCenter(), and geo::vect::normalize().
Referenced by SortSubVolumes().
void geo::TPCGeo::SortSubVolumes | ( | geo::GeoObjectSorter const & | sorter | ) |
Apply sorting to the PlaneGeo objects.
Definition at line 226 of file TPCGeo.cxx.
References fPlane0Pitch, fPlaneLocation, fPlanes, fViewToPlaneNumber, geo::PlaneID::InvalidID, geo::kUnknown, Nplanes(), geo::origin(), and SortPlanes().
Referenced by geo::CryostatGeo::SortSubVolumes(), and toLocalCoords().
|
inline |
Transform point from world frame to local TPC frame.
Definition at line 522 of file TPCGeo.h.
References fTrans, and geo::LocalTransformationGeo< StoredMatrix, LocalPoint, LocalVector >::toLocalCoords().
|
inline |
Transform direction vector from world to local.
Definition at line 534 of file TPCGeo.h.
References DetectDriftDirection(), fTrans, art::detail::indent(), PrintTPCInfo(), SortSubVolumes(), geo::LocalTransformationGeo< StoredMatrix, LocalPoint, LocalVector >::toLocalCoords(), and UpdateAfterSorting().
|
inline |
Half width (associated with x coordinate) of active TPC volume [cm].
Definition at line 112 of file TPCGeo.h.
References fTotalVolume.
|
inline |
Transform point from local TPC frame to world frame.
Definition at line 498 of file TPCGeo.h.
References fTrans, and geo::LocalTransformationGeo< StoredMatrix, LocalPoint, LocalVector >::toWorldCoords().
Referenced by GetCenter(), and InitTPCBoundaries().
|
inline |
Transform direction vector from local to world.
Definition at line 510 of file TPCGeo.h.
References fTrans, and geo::LocalTransformationGeo< StoredMatrix, LocalPoint, LocalVector >::toWorldCoords().
void geo::TPCGeo::UpdateAfterSorting | ( | geo::TPCID | tpcid | ) |
Performs all updates after cryostat has sorted TPCs.
Definition at line 266 of file TPCGeo.cxx.
References DriftDir(), e, fID, fPlanes, lar::util::makeVector3DComparison(), Nplanes(), and UpdatePlaneViewCache().
Referenced by toLocalCoords().
|
private |
Refills the plane vs. view cache of the TPC.
Definition at line 520 of file TPCGeo.cxx.
References fPlanes, fViewToPlaneNumber, geo::PlaneID::InvalidID, geo::kUnknown, and Nplanes().
Referenced by UpdateAfterSorting().
|
inline |
Returns the projection of the specified vector on the plane.
v | the 3D vector to be projected, in world units [cm] |
The returned vector is a 2D vector expressing the projection of the vector (from world units) on the reference plane. The vector is expressed as , components following the width direction (RefWidthDir()
) and the depth direction (RefDepthDir()
) respectively. All coordinates are in centimeters.
Definition at line 438 of file TPCGeo.h.
References Projection().
|
inline |
Returns the projection of the specified vector on the plane.
v | the 3D vector to be projected, in world units [cm] |
The returned vector is a 2D vector expressing the projection of the vector (from world units) on the reference plane. The vector is expressed as , components following the width direction (RefWidthDir()
) and the depth direction (RefDepthDir()
) respectively. All coordinates are in centimeters.
Definition at line 440 of file TPCGeo.h.
References Projection(), and geo::vect::toVector().
std::set< geo::View_t > geo::TPCGeo::Views | ( | ) | const |
Returns a set of all views covered in this TPC.
Definition at line 344 of file TPCGeo.cxx.
References fPlanes, and geo::PlaneGeo::View().
Referenced by LastPlane().
|
inline |
Width is associated with x coordinate [cm].
Definition at line 101 of file TPCGeo.h.
References HalfWidth().
Referenced by PrintTPCInfo().
|
inline |
double geo::TPCGeo::WirePitch | ( | unsigned | plane = 0 | ) | const |
Returns the center of the TPC volume in world coordinates [cm].
Definition at line 427 of file TPCGeo.cxx.
References Plane(), and geo::PlaneGeo::WirePitch().
Referenced by ActiveBoundingBox(), hit::MagDriftAna::analyze(), geo::ChannelMapStandardAlg::Initialize(), and trkf::SpacePointAlg::update().
|
inline |
Transform point from world frame to local TPC frame.
Definition at line 514 of file TPCGeo.h.
References fTrans, and geo::LocalTransformation< StoredMatrix >::WorldToLocal().
|
inline |
Transform point from world frame to local TPC frame.
Definition at line 518 of file TPCGeo.h.
References fTrans, and geo::LocalTransformation< StoredMatrix >::WorldToLocal().
|
inline |
Transform direction vector from world to local.
Definition at line 526 of file TPCGeo.h.
References fTrans, and geo::LocalTransformation< StoredMatrix >::WorldToLocalVect().
|
inline |
Transform direction vector from world to local.
Definition at line 530 of file TPCGeo.h.
References fTrans, and geo::LocalTransformation< StoredMatrix >::WorldToLocalVect().
|
private |
Box of the active volume.
Definition at line 652 of file TPCGeo.h.
Referenced by ActiveBoundingBox(), and InitTPCBoundaries().
|
private |
Center of the active volume, in world coordinates [cm].
Definition at line 638 of file TPCGeo.h.
Referenced by GetActiveVolumeCenter(), and TPCGeo().
|
private |
Half height of active volume.
Definition at line 641 of file TPCGeo.h.
Referenced by ActiveHalfHeight(), and TPCGeo().
|
private |
Half width of active volume.
Definition at line 640 of file TPCGeo.h.
Referenced by ActiveHalfWidth(), and TPCGeo().
|
private |
Length of active volume.
Definition at line 642 of file TPCGeo.h.
Referenced by ActiveHalfLength(), ActiveLength(), and TPCGeo().
|
private |
Active volume of LAr, called volTPCActive in GDML file.
Definition at line 633 of file TPCGeo.h.
Referenced by ActiveMass(), ActiveVolume(), and TPCGeo().
|
private |
Direction electrons drift along.
Definition at line 650 of file TPCGeo.h.
Referenced by DriftDir(), and ResetDriftDirection().
|
private |
Direction of the electron drift in the TPC.
Definition at line 635 of file TPCGeo.h.
Referenced by DriftDirection(), and ResetDriftDirection().
|
private |
Half height of total volume.
Definition at line 644 of file TPCGeo.h.
Referenced by HalfHeight(), and TPCGeo().
|
private |
Half width of total volume.
Definition at line 643 of file TPCGeo.h.
Referenced by HalfWidth(), and TPCGeo().
|
private |
Direction height refers to.
Definition at line 648 of file TPCGeo.h.
Referenced by HeightDir(), and TPCGeo().
|
private |
ID of this TPC.
Definition at line 654 of file TPCGeo.h.
Referenced by ID(), and UpdateAfterSorting().
|
private |
Length of total volume.
Definition at line 645 of file TPCGeo.h.
Referenced by HalfLength(), Length(), and TPCGeo().
|
private |
Direction length refers to.
Definition at line 649 of file TPCGeo.h.
Referenced by LengthDir(), and TPCGeo().
|
private |
Pitch between planes.
Definition at line 636 of file TPCGeo.h.
Referenced by Plane0Pitch(), PlanePitch(), and SortSubVolumes().
|
private |
xyz locations of planes in the TPC.
Definition at line 637 of file TPCGeo.h.
Referenced by PlaneLocation(), and SortSubVolumes().
|
private |
List of planes in this plane.
Definition at line 632 of file TPCGeo.h.
Referenced by ComputeDriftDistance(), DriftDistance(), FirstPlane(), LastPlane(), MakePlane(), MaxWires(), NElements(), Plane(), PlanePtr(), SmallestPlane(), SortSubVolumes(), UpdateAfterSorting(), UpdatePlaneViewCache(), and Views().
|
private |
Total volume of TPC, called volTPC in GDML file.
Definition at line 634 of file TPCGeo.h.
Referenced by TotalVolume(), and TPCGeo().
|
private |
TPC-to-world transformation.
Definition at line 630 of file TPCGeo.h.
Referenced by LocalToWorld(), LocalToWorldVect(), toLocalCoords(), toWorldCoords(), TPCGeo(), WorldToLocal(), and WorldToLocalVect().
|
private |
Index of the plane for each view (InvalidID if none).
Definition at line 657 of file TPCGeo.h.
Referenced by Plane(), SortSubVolumes(), and UpdatePlaneViewCache().
|
private |
Direction width refers to.
Definition at line 647 of file TPCGeo.h.
Referenced by TPCGeo(), and WidthDir().
|
static |
Maximum verbosity supported by PrintTPCInfo()
.
Definition at line 595 of file TPCGeo.h.
Referenced by geo::GeometryCore::Print().