ATLAS Offline Software
Public Types | Public Member Functions | Protected Member Functions | Private Member Functions | Private Attributes | Friends | List of all members
Trk::DiamondBounds Class Referencefinal

#include <DiamondBounds.h>

Inheritance diagram for Trk::DiamondBounds:
Collaboration diagram for Trk::DiamondBounds:

Public Types

enum  BoundValues {
  bv_minHalfX = 0, bv_medHalfX = 1, bv_maxHalfX = 2, bv_halfY1 = 3,
  bv_halfY2 = 4, bv_length = 5
}
 BoundValues for better readability. More...
 
enum  BoundsType {
  Cone = 0, Cylinder = 1, Diamond = 2, Disc = 3,
  Ellipse = 5, Rectangle = 6, RotatedTrapezoid = 7, Trapezoid = 8,
  Triangle = 9, DiscTrapezoidal = 10, Annulus = 11, Other = 12
}
 

Public Member Functions

 DiamondBounds ()
 Default Constructor, needed for persistency. More...
 
 DiamondBounds (const DiamondBounds &diabo)=default
 Copy constructor. More...
 
DiamondBoundsoperator= (const DiamondBounds &sbo)=default
 Assignment operator. More...
 
 DiamondBounds (DiamondBounds &&diabo) noexcept=default
 Copy constructor. More...
 
DiamondBoundsoperator= (DiamondBounds &&sbo) noexcept=default
 Assignment operator. More...
 
virtual ~DiamondBounds ()=default
 Destructor. More...
 
 DiamondBounds (double minhalex, double medhalex, double maxhalex, double haley1, double haley2)
 Constructor for symmetric Diamond. More...
 
DiamondBoundsclone () const override
 Virtual constructor. More...
 
virtual bool operator== (const SurfaceBounds &diabo) const override
 Equality operator. More...
 
virtual BoundsType type () const override final
 Return the bounds type. More...
 
double minHalflengthX () const
 This method returns the halflength in X at minimal Y (first coordinate of local surface frame) More...
 
double medHalflengthX () const
 This method returns the (maximal) halflength in X (first coordinate of local surface frame) More...
 
double maxHalflengthX () const
 This method returns the halflength in X at maximal Y (first coordinate of local surface frame) More...
 
double halflengthY1 () const
 This method returns the halflength in Y of trapezoid at negative/positive Y (second coordinate) More...
 
double halflengthY2 () const
 
virtual double r () const override final
 This method returns the maximal extension on the local plane. More...
 
double alpha1 () const
 This method returns the opening angle alpha in point A
More...
 
double alpha2 () const
 This method returns the opening angle alpha in point A'
More...
 
virtual bool inside (const Amg::Vector2D &locpo, double tol1=0., double tol2=0.) const override final
 The orientation of the Diamond is according to the figure. More...
 
virtual bool inside (const Amg::Vector2D &locpo, const BoundaryCheck &bchk) const override final
 
virtual bool insideLoc1 (const Amg::Vector2D &locpo, double tol1=0.) const override final
 This method checks inside bounds in loc1. More...
 
virtual bool insideLoc2 (const Amg::Vector2D &locpo, double tol2=0.) const override final
 This method checks inside bounds in loc2. More...
 
virtual double minDistance (const Amg::Vector2D &pos) const override final
 Minimal distance to boundary ( > 0 if outside and <=0 if inside) More...
 
virtual MsgStream & dump (MsgStream &sl) const override final
 Output Method for MsgStream. More...
 
virtual std::ostream & dump (std::ostream &sl) const override final
 Output Method for std::ostream. More...
 
virtual bool operator!= (const SurfaceBounds &sb) const
 Non-Equality operator. More...
 

Protected Member Functions

void swap (double &b1, double &b2)
 Swap method to be called from DiscBounds or TrapezoidalBounds. More...
 

Private Member Functions

bool insideFull (const Amg::Vector2D &locpo, double tol1=0., double tol2=0.) const
 inside() method for a full symmetric diamond More...
 
virtual void initCache () override
 initialize the alpha1/2 cache - needed also for object persistency More...
 

Private Attributes

std::vector< TDD_real_tm_boundValues
 Internal parameters stored in the geometry. More...
 
TDD_real_t m_alpha1
 
TDD_real_t m_alpha2
 

Friends

class ::DiamondBoundsCnv_p1
 

Detailed Description

Bounds for a double trapezoidal ("diamond"), planar Surface.

Author
Andre.nosp@m.as.S.nosp@m.alzbu.nosp@m.rger.nosp@m.@cern.nosp@m..ch, Sarka.nosp@m..Tod.nosp@m.orova.nosp@m.@cer.nosp@m.n.ch

Definition at line 36 of file DiamondBounds.h.

Member Enumeration Documentation

◆ BoundsType

This enumerator simplifies the persistency, by saving a dynamic_cast to happen.

Other is reserved for the GeometrySurfaces implementation.

Enumerator
Cone 
Cylinder 
Diamond 
Disc 
Ellipse 
Rectangle 
RotatedTrapezoid 
Trapezoid 
Triangle 
DiscTrapezoidal 
Annulus 
Other 

Definition at line 58 of file SurfaceBounds.h.

59  {
60  Cone = 0,
61  Cylinder = 1,
62  Diamond = 2,
63  Disc = 3,
64  Ellipse = 5,
65  Rectangle = 6,
66  RotatedTrapezoid = 7,
67  Trapezoid = 8,
68  Triangle = 9,
69  DiscTrapezoidal = 10,
70  Annulus = 11,
71  Other = 12
72 
73  };

◆ BoundValues

BoundValues for better readability.

Enumerator
bv_minHalfX 
bv_medHalfX 
bv_maxHalfX 
bv_halfY1 
bv_halfY2 
bv_length 

Definition at line 41 of file DiamondBounds.h.

42  {
43  bv_minHalfX = 0,
44  bv_medHalfX = 1,
45  bv_maxHalfX = 2,
46  bv_halfY1 = 3,
47  bv_halfY2 = 4,
48  bv_length = 5
49  };

Constructor & Destructor Documentation

◆ DiamondBounds() [1/4]

Trk::DiamondBounds::DiamondBounds ( )

Default Constructor, needed for persistency.

Definition at line 19 of file DiamondBounds.cxx.

21  , m_alpha1(0.)
22  , m_alpha2(0.)
23 {}

◆ DiamondBounds() [2/4]

Trk::DiamondBounds::DiamondBounds ( const DiamondBounds diabo)
default

Copy constructor.

◆ DiamondBounds() [3/4]

Trk::DiamondBounds::DiamondBounds ( DiamondBounds &&  diabo)
defaultnoexcept

Copy constructor.

◆ ~DiamondBounds()

virtual Trk::DiamondBounds::~DiamondBounds ( )
virtualdefault

Destructor.

◆ DiamondBounds() [4/4]

Trk::DiamondBounds::DiamondBounds ( double  minhalex,
double  medhalex,
double  maxhalex,
double  haley1,
double  haley2 
)

Constructor for symmetric Diamond.

Definition at line 26 of file DiamondBounds.cxx.

Member Function Documentation

◆ alpha1()

double Trk::DiamondBounds::alpha1 ( ) const

This method returns the opening angle alpha in point A

Definition at line 179 of file DiamondBounds.cxx.

180 {
181  return m_alpha1;
182 }

◆ alpha2()

double Trk::DiamondBounds::alpha2 ( ) const

This method returns the opening angle alpha in point A'

Definition at line 186 of file DiamondBounds.cxx.

187 {
188  return m_alpha2;
189 }

◆ clone()

DiamondBounds* Trk::DiamondBounds::clone ( ) const
overridevirtual

Virtual constructor.

Implements Trk::SurfaceBounds.

◆ dump() [1/2]

MsgStream & Trk::DiamondBounds::dump ( MsgStream &  sl) const
finaloverridevirtual

Output Method for MsgStream.

Implements Trk::SurfaceBounds.

Definition at line 243 of file DiamondBounds.cxx.

244 {
245  sl << std::setiosflags(std::ios::fixed);
246  sl << std::setprecision(7);
247  sl << "Trk::DiamondBounds: (minHlenghtX, medHlengthX, maxHlengthX, hlengthY1, hlengthY2 ) = ";
251  sl << std::setprecision(-1);
252  return sl;
253 }

◆ dump() [2/2]

std::ostream & Trk::DiamondBounds::dump ( std::ostream &  sl) const
finaloverridevirtual

Output Method for std::ostream.

Implements Trk::SurfaceBounds.

Definition at line 256 of file DiamondBounds.cxx.

257 {
258  sl << std::setiosflags(std::ios::fixed);
259  sl << std::setprecision(7);
260  sl << "Trk::DiamondBounds: (minHlenghtX, medHlengthX, maxHlengthX, hlengthY1, hlengthY2 ) = ";
264  sl << std::setprecision(-1);
265  return sl;
266 }

◆ halflengthY1()

double Trk::DiamondBounds::halflengthY1 ( ) const

This method returns the halflength in Y of trapezoid at negative/positive Y (second coordinate)

◆ halflengthY2()

double Trk::DiamondBounds::halflengthY2 ( ) const

◆ initCache()

void Trk::DiamondBounds::initCache ( )
overrideprivatevirtual

initialize the alpha1/2 cache - needed also for object persistency

Reimplemented from Trk::SurfaceBounds.

Definition at line 40 of file DiamondBounds.cxx.

◆ inside() [1/2]

bool Trk::DiamondBounds::inside ( const Amg::Vector2D locpo,
const BoundaryCheck bchk 
) const
finaloverridevirtual

Implements Trk::SurfaceBounds.

Definition at line 67 of file DiamondBounds.cxx.

69 {
70  if (bchk.bcType == 0)
71  return DiamondBounds::inside(locpo, bchk.toleranceLoc1, bchk.toleranceLoc2);
72 
73  // a fast FALSE
74  double max_ell = bchk.lCovariance(0, 0) > bchk.lCovariance(1, 1)
75  ? bchk.lCovariance(0, 0)
76  : bchk.lCovariance(1, 1);
77  double limit = bchk.nSigmas * sqrt(max_ell);
79  return false;
81  return false;
82  // a fast FALSE
83  double fabsX = std::abs(locpo[Trk::locX]);
85  return false;
86  // a fast TRUE
87  double min_ell = bchk.lCovariance(0, 0) < bchk.lCovariance(1, 1)
88  ? bchk.lCovariance(0, 0)
89  : bchk.lCovariance(1, 1);
90  limit = bchk.nSigmas * sqrt(min_ell);
91  if (fabsX < (fmin(m_boundValues[DiamondBounds::bv_minHalfX],
93  limit))
94  return true;
95  // a fast TRUE
96  if (std::abs(locpo[Trk::locY]) < (fmin(m_boundValues[DiamondBounds::bv_halfY1],
98  limit))
99  return true;
100 
101  // compute KDOP and axes for surface polygon
102  std::vector<KDOP> elementKDOP(5);
103  std::vector<Amg::Vector2D> elementP(6);
104  float theta =
105  (bchk.lCovariance(1, 0) != 0 &&
106  (bchk.lCovariance(1, 1) - bchk.lCovariance(0, 0)) != 0)
107  ? .5 * bchk.FastArcTan(2 * bchk.lCovariance(1, 0) /
108  (bchk.lCovariance(1, 1) - bchk.lCovariance(0, 0)))
109  : 0.;
110  sincosCache scResult = bchk.FastSinCos(theta);
111  AmgMatrix(2, 2) rotMatrix;
112  rotMatrix << scResult.cosC, scResult.sinC, -scResult.sinC, scResult.cosC;
113  AmgMatrix(2, 2) normal;
114  // cppcheck-suppress constStatement
115  normal << 0, -1, 1, 0;
116  // ellipse is always at (0,0), surface is moved to ellipse position and then
117  // rotated
118  Amg::Vector2D p =
121  elementP[0] = (rotMatrix * (p - locpo));
123  elementP[1] = (rotMatrix * (p - locpo));
126  elementP[2] = (rotMatrix * (p - locpo));
129  elementP[3] = (rotMatrix * (p - locpo));
131  elementP[4] = (rotMatrix * (p - locpo));
134  elementP[5] = (rotMatrix * (p - locpo));
135  std::vector<Amg::Vector2D> axis = { normal * (elementP[1] - elementP[0]),
136  normal * (elementP[2] - elementP[1]),
137  normal * (elementP[3] - elementP[2]),
138  normal * (elementP[4] - elementP[3]),
139  normal * (elementP[5] - elementP[4]) };
140  bchk.ComputeKDOP(elementP, axis, elementKDOP);
141  // compute KDOP for error ellipse
142  std::vector<KDOP> errelipseKDOP(5);
143  bchk.ComputeKDOP(bchk.EllipseToPoly(3), axis, errelipseKDOP);
144  // check if KDOPs overlap and return result
145  return bchk.TestKDOPKDOP(elementKDOP, errelipseKDOP);
146 }

◆ inside() [2/2]

bool Trk::DiamondBounds::inside ( const Amg::Vector2D locpo,
double  tol1 = 0.,
double  tol2 = 0. 
) const
finaloverridevirtual

The orientation of the Diamond is according to the figure.

Implements Trk::SurfaceBounds.

Definition at line 61 of file DiamondBounds.cxx.

62 {
63  return this->insideFull(locpo, tol1, tol2);
64 }

◆ insideFull()

bool Trk::DiamondBounds::insideFull ( const Amg::Vector2D locpo,
double  tol1 = 0.,
double  tol2 = 0. 
) const
private

inside() method for a full symmetric diamond

use basic calculation of a straight line

Definition at line 150 of file DiamondBounds.cxx.

151 {
152  // validity check
154 
155  // quick False (radial direction)
156  if (locpo[Trk::locY] < -2. * m_boundValues[DiamondBounds::bv_halfY1] - tol2) return false;
157  if (locpo[Trk::locY] > 2. * m_boundValues[DiamondBounds::bv_halfY2] + tol2) return false;
158 
159  double absX = std::abs(locpo[Trk::locX]);
160 
161  // quick False (transverse directon)
162  if (absX > m_boundValues[DiamondBounds::bv_medHalfX] + tol1) return false;
163 
164  // quick True
166 
171  double k = halfH ? 0.5*(halfBaseUp - halfBaseLo)/halfH : 0.;
172  double sign = (k < 0) ? -1. : 1.;
173  return (absX - tol1 <= m_boundValues[DiamondBounds::bv_medHalfX] + k * (locpo[Trk::locY] + sign*tol2));
174 
175 }

◆ insideLoc1()

virtual bool Trk::DiamondBounds::insideLoc1 ( const Amg::Vector2D locpo,
double  tol1 = 0. 
) const
finaloverridevirtual

This method checks inside bounds in loc1.

  • loc1/loc2 correspond to the natural coordinates of the surface
  • As loc1/loc2 are correlated the single check doesn't make sense : -> check is done on enclosing Rectangle !

Implements Trk::SurfaceBounds.

◆ insideLoc2()

virtual bool Trk::DiamondBounds::insideLoc2 ( const Amg::Vector2D locpo,
double  tol2 = 0. 
) const
finaloverridevirtual

This method checks inside bounds in loc2.

  • loc1/loc2 correspond to the natural coordinates of the surface
  • As loc1/loc2 are correlated the single check doesn't make sense : -> check is done on enclosing Rectangle !

Implements Trk::SurfaceBounds.

◆ maxHalflengthX()

double Trk::DiamondBounds::maxHalflengthX ( ) const

This method returns the halflength in X at maximal Y (first coordinate of local surface frame)

◆ medHalflengthX()

double Trk::DiamondBounds::medHalflengthX ( ) const

This method returns the (maximal) halflength in X (first coordinate of local surface frame)

◆ minDistance()

double Trk::DiamondBounds::minDistance ( const Amg::Vector2D pos) const
finaloverridevirtual

Minimal distance to boundary ( > 0 if outside and <=0 if inside)

Implements Trk::SurfaceBounds.

Definition at line 192 of file DiamondBounds.cxx.

193 {
194  const int Np = 6;
195 
198 
202  double Y[6] = { -y1, 0., y2, y2, 0., -y1 };
203 
204  double dm = 1.e+20;
205  double Ao = 0.;
206  bool in = true;
207 
208  for (int i = 0; i != Np; ++i) {
209 
210  int j = (i == Np-1 ? 0 : i+1);
211 
212  double x = X[i] - pos[0];
213  double y = Y[i] - pos[1];
214  double dx = X[j] - X[i];
215  double dy = Y[j] - Y[i];
216  double A = x * dy - y * dx;
217  double S = -(x * dx + y * dy);
218 
219  if (S <= 0.) {
220  double d = x * x + y * y;
221  if (d < dm)
222  dm = d;
223  } else {
224  double a = dx * dx + dy * dy;
225  if (S <= a) {
226  double d = (A * A) / a;
227  if (d < dm)
228  dm = d;
229  }
230  }
231  if (i && in && Ao * A < 0.)
232  in = false;
233  Ao = A;
234  }
235  if (in)
236  return -sqrt(dm);
237  return sqrt(dm);
238 }

◆ minHalflengthX()

double Trk::DiamondBounds::minHalflengthX ( ) const

This method returns the halflength in X at minimal Y (first coordinate of local surface frame)

◆ operator!=()

bool Trk::SurfaceBounds::operator!= ( const SurfaceBounds sb) const
inlinevirtualinherited

Non-Equality operator.

Reimplemented in Trk::InvalidBounds.

Definition at line 141 of file SurfaceBounds.h.

142 {
143  return !((*this) == sb);
144 }

◆ operator=() [1/2]

DiamondBounds& Trk::DiamondBounds::operator= ( const DiamondBounds sbo)
default

Assignment operator.

◆ operator=() [2/2]

DiamondBounds& Trk::DiamondBounds::operator= ( DiamondBounds &&  sbo)
defaultnoexcept

Assignment operator.

◆ operator==()

bool Trk::DiamondBounds::operator== ( const SurfaceBounds diabo) const
overridevirtual

Equality operator.

Implements Trk::SurfaceBounds.

Definition at line 50 of file DiamondBounds.cxx.

51 {
52  // check the type first not to compare apples with oranges
53  const Trk::DiamondBounds* diabo = dynamic_cast<const Trk::DiamondBounds*>(&sbo);
54  if (!diabo)
55  return false;
56  return (m_boundValues == diabo->m_boundValues);
57 }

◆ r()

virtual double Trk::DiamondBounds::r ( ) const
finaloverridevirtual

This method returns the maximal extension on the local plane.

Implements Trk::SurfaceBounds.

◆ swap()

void Trk::SurfaceBounds::swap ( double &  b1,
double &  b2 
)
inlineprotectedinherited

Swap method to be called from DiscBounds or TrapezoidalBounds.

Definition at line 133 of file SurfaceBounds.h.

134 {
135  double tmp = b1;
136  b1 = b2;
137  b2 = tmp;
138 }

◆ type()

virtual BoundsType Trk::DiamondBounds::type ( ) const
inlinefinaloverridevirtual

Return the bounds type.

Implements Trk::SurfaceBounds.

Definition at line 79 of file DiamondBounds.h.

79 { return SurfaceBounds::Diamond; }

Friends And Related Function Documentation

◆ ::DiamondBoundsCnv_p1

friend class ::DiamondBoundsCnv_p1
friend

Definition at line 131 of file DiamondBounds.h.

Member Data Documentation

◆ m_alpha1

TDD_real_t Trk::DiamondBounds::m_alpha1
private

Definition at line 141 of file DiamondBounds.h.

◆ m_alpha2

TDD_real_t Trk::DiamondBounds::m_alpha2
private

Definition at line 142 of file DiamondBounds.h.

◆ m_boundValues

std::vector<TDD_real_t> Trk::DiamondBounds::m_boundValues
private

Internal parameters stored in the geometry.

Definition at line 140 of file DiamondBounds.h.


The documentation for this class was generated from the following files:
Trk::y
@ y
Definition: ParamDefs.h:62
Trk::AmgMatrix
AmgMatrix(3, 3) NeutralParticleParameterCalculator
Definition: NeutralParticleParameterCalculator.cxx:233
Trk::SurfaceBounds::DiscTrapezoidal
@ DiscTrapezoidal
Definition: SurfaceBounds.h:69
Trk::DiamondBounds::insideFull
bool insideFull(const Amg::Vector2D &locpo, double tol1=0., double tol2=0.) const
inside() method for a full symmetric diamond
Definition: DiamondBounds.cxx:150
python.PerfMonSerializer.p
def p
Definition: PerfMonSerializer.py:743
Trk::SurfaceBounds::Cone
@ Cone
Definition: SurfaceBounds.h:60
Trk::locX
@ locX
Definition: ParamDefs.h:43
Trk::locY
@ locY
local cartesian
Definition: ParamDefs.h:44
Amg::Vector2D
Eigen::Matrix< double, 2, 1 > Vector2D
Definition: GeoPrimitives.h:48
Trk::SurfaceBounds::Rectangle
@ Rectangle
Definition: SurfaceBounds.h:65
hist_file_dump.d
d
Definition: hist_file_dump.py:137
Trk::SurfaceBounds::swap
void swap(double &b1, double &b2)
Swap method to be called from DiscBounds or TrapezoidalBounds.
Definition: SurfaceBounds.h:133
yodamerge_tmp.axis
list axis
Definition: yodamerge_tmp.py:241
Trk::DiamondBounds::initCache
virtual void initCache() override
initialize the alpha1/2 cache - needed also for object persistency
Definition: DiamondBounds.cxx:40
Trk::SurfaceBounds::Annulus
@ Annulus
Definition: SurfaceBounds.h:70
Trk::SurfaceBounds::Diamond
@ Diamond
Definition: SurfaceBounds.h:62
Trk::DiamondBounds::inside
virtual bool inside(const Amg::Vector2D &locpo, double tol1=0., double tol2=0.) const override final
The orientation of the Diamond is according to the figure.
Definition: DiamondBounds.cxx:61
JetTiledMap::S
@ S
Definition: TiledEtaPhiMap.h:44
makeTRTBarrelCans.y1
tuple y1
Definition: makeTRTBarrelCans.py:15
Monitored::X
@ X
Definition: HistogramFillerUtils.h:24
dqt_zlumi_alleff_HIST.A
A
Definition: dqt_zlumi_alleff_HIST.py:110
Trk::DiamondBounds::m_alpha1
TDD_real_t m_alpha1
Definition: DiamondBounds.h:141
Trk::DiamondBounds::m_boundValues
std::vector< TDD_real_t > m_boundValues
Internal parameters stored in the geometry.
Definition: DiamondBounds.h:140
Trk::DiamondBounds::bv_medHalfX
@ bv_medHalfX
Definition: DiamondBounds.h:44
Trk::DiamondBounds
Definition: DiamondBounds.h:37
lumiFormat.i
int i
Definition: lumiFormat.py:92
Trk::theta
@ theta
Definition: ParamDefs.h:72
vector
Definition: MultiHisto.h:13
makeTRTBarrelCans.y2
tuple y2
Definition: makeTRTBarrelCans.py:18
Trk::DiamondBounds::bv_halfY1
@ bv_halfY1
Definition: DiamondBounds.h:46
sign
int sign(int a)
Definition: TRT_StrawNeighbourSvc.h:127
DeMoUpdate.tmp
string tmp
Definition: DeMoUpdate.py:1167
Trk::DiamondBounds::DiamondBounds
DiamondBounds()
Default Constructor, needed for persistency.
Definition: DiamondBounds.cxx:19
ReadCellNoiseFromCool.dm
dm
Definition: ReadCellNoiseFromCool.py:235
min
#define min(a, b)
Definition: cfImp.cxx:40
Monitored::Y
@ Y
Definition: HistogramFillerUtils.h:24
keylayer_zslicemap.sb
sb
Definition: keylayer_zslicemap.py:192
Amg
Definition of ATLAS Math & Geometry primitives (Amg)
Definition: AmgStringHelpers.h:19
Trk::DiamondBounds::bv_maxHalfX
@ bv_maxHalfX
Definition: DiamondBounds.h:45
Trk::SurfaceBounds::Trapezoid
@ Trapezoid
Definition: SurfaceBounds.h:67
python.LumiBlobConversion.pos
pos
Definition: LumiBlobConversion.py:18
makeTRTBarrelCans.dy
tuple dy
Definition: makeTRTBarrelCans.py:21
a
TList * a
Definition: liststreamerinfos.cxx:10
Trk::SurfaceBounds::Disc
@ Disc
Definition: SurfaceBounds.h:63
Trk::DiamondBounds::bv_minHalfX
@ bv_minHalfX
Definition: DiamondBounds.h:43
Trk::DiamondBounds::m_alpha2
TDD_real_t m_alpha2
Definition: DiamondBounds.h:142
makeTRTBarrelCans.dx
tuple dx
Definition: makeTRTBarrelCans.py:20
Trk::DiamondBounds::bv_length
@ bv_length
Definition: DiamondBounds.h:48
Trk::SurfaceBounds::RotatedTrapezoid
@ RotatedTrapezoid
Definition: SurfaceBounds.h:66
Trk::SurfaceBounds::Other
@ Other
Definition: SurfaceBounds.h:71
Trk::x
@ x
Definition: ParamDefs.h:61
Trk::SurfaceBounds::Triangle
@ Triangle
Definition: SurfaceBounds.h:68
updateCoolNtuple.limit
int limit
Definition: updateCoolNtuple.py:45
Trk::SurfaceBounds::Ellipse
@ Ellipse
Definition: SurfaceBounds.h:64
Trk::DiamondBounds::bv_halfY2
@ bv_halfY2
Definition: DiamondBounds.h:47
fitman.k
k
Definition: fitman.py:528
Trk::SurfaceBounds::Cylinder
@ Cylinder
Definition: SurfaceBounds.h:61