CMS 3D CMS Logo

List of all members | Public Member Functions | Private Member Functions | Static Private Member Functions | Private Attributes | Friends
ClosestApproachInRPhi Class Referencefinal

#include <ClosestApproachInRPhi.h>

Inheritance diagram for ClosestApproachInRPhi:
ClosestApproachOnHelices

Public Member Functions

bool calculate (const FreeTrajectoryState &sta, const FreeTrajectoryState &stb) override
 
bool calculate (const TrajectoryStateOnSurface &sta, const TrajectoryStateOnSurface &stb) override
 
ClosestApproachInRPhiclone () const override
 
 ClosestApproachInRPhi ()
 
GlobalPoint crossingPoint () const override
 
float distance () const override
 
std::pair< GlobalPoint, GlobalPointpoints () const override
 
bool status () const override
 
std::pair< GlobalTrajectoryParameters, GlobalTrajectoryParameterstrajectoryParameters () const
 
 ~ClosestApproachInRPhi () override
 
- Public Member Functions inherited from ClosestApproachOnHelices
 ClosestApproachOnHelices ()
 
virtual ~ClosestApproachOnHelices ()
 

Private Member Functions

bool compute (const TrackCharge &chargeA, const GlobalVector &momentumA, const GlobalPoint &positionA, const TrackCharge &chargeB, const GlobalVector &momentumB, const GlobalPoint &positionB)
 

Static Private Member Functions

static void circleParameters (const TrackCharge &charge, const GlobalVector &momemtum, const GlobalPoint &position, double &xc, double &yc, double &r, double bz)
 
static GlobalTrajectoryParameters newTrajectory (const GlobalPoint &newpt, const GlobalTrajectoryParameters &oldpar, double bz)
 
static int transverseCoord (double cxa, double cya, double ra, double cxb, double cyb, double rb, double &xg1, double &yg1, double &xg2, double &yg2)
 
static double zCoord (const GlobalVector &mom, const GlobalPoint &pos, double r, double xc, double yc, double xg, double yg)
 

Private Attributes

double bz
 
GlobalTrajectoryParameters paramA
 
GlobalTrajectoryParameters paramB
 
GlobalPoint posA
 
GlobalPoint posB
 
bool status_
 

Friends

int test::ClosestApproachInRPhi_t::test ()
 

Detailed Description

Definition at line 26 of file ClosestApproachInRPhi.h.

Constructor & Destructor Documentation

◆ ClosestApproachInRPhi()

ClosestApproachInRPhi::ClosestApproachInRPhi ( )
inline

Definition at line 30 of file ClosestApproachInRPhi.h.

30 { status_ = false; }

References status_.

Referenced by clone().

◆ ~ClosestApproachInRPhi()

ClosestApproachInRPhi::~ClosestApproachInRPhi ( )
inlineoverride

Definition at line 31 of file ClosestApproachInRPhi.h.

31 {}

Member Function Documentation

◆ calculate() [1/2]

bool ClosestApproachInRPhi::calculate ( const FreeTrajectoryState sta,
const FreeTrajectoryState stb 
)
overridevirtual

Implements ClosestApproachOnHelices.

Definition at line 23 of file ClosestApproachInRPhi.cc.

23  {
24  TrackCharge chargeA = sta.charge();
25  TrackCharge chargeB = stb.charge();
26  GlobalVector momentumA = sta.momentum();
27  GlobalVector momentumB = stb.momentum();
28  GlobalPoint positionA = sta.position();
29  GlobalPoint positionB = stb.position();
30  paramA = sta.parameters();
31  paramB = stb.parameters();
32  // compute magnetic field ONCE
33  bz = sta.parameters().magneticField().inTesla(positionA).z() * 2.99792458e-3;
34 
35  return compute(chargeA, momentumA, positionA, chargeB, momentumB, positionB);
36 }

References FreeTrajectoryState::charge(), bookConverter::compute(), MagneticField::inTesla(), GlobalTrajectoryParameters::magneticField(), FreeTrajectoryState::momentum(), FreeTrajectoryState::parameters(), FreeTrajectoryState::position(), and PV3DBase< T, PVType, FrameType >::z().

◆ calculate() [2/2]

bool ClosestApproachInRPhi::calculate ( const TrajectoryStateOnSurface sta,
const TrajectoryStateOnSurface stb 
)
overridevirtual

◆ circleParameters()

void ClosestApproachInRPhi::circleParameters ( const TrackCharge charge,
const GlobalVector momemtum,
const GlobalPoint position,
double &  xc,
double &  yc,
double &  r,
double  bz 
)
staticprivate

temporary code, to be replaced by call to curvature() when bug is fixed.

end of temporary code

Definition at line 169 of file ClosestApproachInRPhi.cc.

175  {
176  // compute radius of circle
180  // double bz = MagneticField::inInverseGeV(position).z();
181 
182  // signed_r directed towards circle center, along F_Lorentz = q*v X B
183  double qob = charge / bz;
184  double signed_r = qob * momentum.transverse();
185  r = abs(signed_r);
189  // compute centre of circle
190  // double phi = momentum.phi();
191  // xc = signed_r*sin(phi) + position.x();
192  // yc = -signed_r*cos(phi) + position.y();
193  xc = position.x() + qob * momentum.y();
194  yc = position.y() - qob * momentum.x();
195 }

References funct::abs(), ALCARECOTkAlJpsiMuMu_cff::charge, position, alignCSCRings::r, PV3DBase< T, PVType, FrameType >::transverse(), PV3DBase< T, PVType, FrameType >::x(), and PV3DBase< T, PVType, FrameType >::y().

◆ clone()

ClosestApproachInRPhi* ClosestApproachInRPhi::clone ( void  ) const
inlineoverridevirtual

Clone method

Implements ClosestApproachOnHelices.

Definition at line 57 of file ClosestApproachInRPhi.h.

57 { return new ClosestApproachInRPhi(*this); }

References ClosestApproachInRPhi().

◆ compute()

bool ClosestApproachInRPhi::compute ( const TrackCharge chargeA,
const GlobalVector momentumA,
const GlobalPoint positionA,
const TrackCharge chargeB,
const GlobalVector momentumB,
const GlobalPoint positionB 
)
private

Definition at line 62 of file ClosestApproachInRPhi.cc.

67  {
68  // centres and radii of track circles
69  double xca, yca, ra;
70  circleParameters(chargeA, momentumA, positionA, xca, yca, ra, bz);
71  double xcb, ycb, rb;
72  circleParameters(chargeB, momentumB, positionB, xcb, ycb, rb, bz);
73 
74  // points of closest approach in transverse plane
75  double xg1, yg1, xg2, yg2;
76  int flag = transverseCoord(xca, yca, ra, xcb, ycb, rb, xg1, yg1, xg2, yg2);
77  if (flag == 0) {
78  status_ = false;
79  return false;
80  }
81 
82  double xga, yga, zga, xgb, ygb, zgb;
83 
84  if (flag == 1) {
85  // two crossing points on each track in transverse plane
86  // select point for which z-coordinates on the 2 tracks are the closest
87  double za1 = zCoord(momentumA, positionA, ra, xca, yca, xg1, yg1);
88  double zb1 = zCoord(momentumB, positionB, rb, xcb, ycb, xg1, yg1);
89  double za2 = zCoord(momentumA, positionA, ra, xca, yca, xg2, yg2);
90  double zb2 = zCoord(momentumB, positionB, rb, xcb, ycb, xg2, yg2);
91 
92  if (abs(zb1 - za1) < abs(zb2 - za2)) {
93  xga = xg1;
94  yga = yg1;
95  zga = za1;
96  zgb = zb1;
97  } else {
98  xga = xg2;
99  yga = yg2;
100  zga = za2;
101  zgb = zb2;
102  }
103  xgb = xga;
104  ygb = yga;
105  } else {
106  // one point of closest approach on each track in transverse plane
107  xga = xg1;
108  yga = yg1;
109  zga = zCoord(momentumA, positionA, ra, xca, yca, xga, yga);
110  xgb = xg2;
111  ygb = yg2;
112  zgb = zCoord(momentumB, positionB, rb, xcb, ycb, xgb, ygb);
113  }
114 
115  posA = GlobalPoint(xga, yga, zga);
116  posB = GlobalPoint(xgb, ygb, zgb);
117  status_ = true;
118  return true;
119 }

References funct::abs(), and RemoveAddSevLevel::flag.

◆ crossingPoint()

GlobalPoint ClosestApproachInRPhi::crossingPoint ( ) const
overridevirtual

arithmetic mean of the two points of closest approach

Implements ClosestApproachOnHelices.

Definition at line 46 of file ClosestApproachInRPhi.cc.

46  {
47  if (!status_)
48  throw cms::Exception(
49  "TrackingTools/PatternTools",
50  "ClosestApproachInRPhi::could not compute track crossing. Check status before calling this method!");
51  return GlobalPoint(0.5 * (posA.basicVector() + posB.basicVector()));
52 }

References Exception.

Referenced by V0Fitter::fitAll(), and ConversionProducer::preselectTrackPair().

◆ distance()

float ClosestApproachInRPhi::distance ( ) const
overridevirtual

distance between the two points of closest approach in 3D

Implements ClosestApproachOnHelices.

Definition at line 54 of file ClosestApproachInRPhi.cc.

54  {
55  if (!status_)
56  throw cms::Exception(
57  "TrackingTools/PatternTools",
58  "ClosestApproachInRPhi::could not compute track crossing. Check status before calling this method!");
59  return (posB - posA).mag();
60 }

References Exception.

Referenced by BPHMonitor::analyze(), HLTMuonDimuonL3Filter::applyDiMuonSelection(), V0Fitter::fitAll(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), HLTMuonTrimuonL3Filter::hltFilter(), and Onia2MuMuPAT::produce().

◆ newTrajectory()

GlobalTrajectoryParameters ClosestApproachInRPhi::newTrajectory ( const GlobalPoint newpt,
const GlobalTrajectoryParameters oldpar,
double  bz 
)
staticprivate

Definition at line 131 of file ClosestApproachInRPhi.cc.

133  {
134  // First we need the centers of the circles.
135  double qob = oldgtp.charge() / bz;
136  double xc = oldgtp.position().x() + qob * oldgtp.momentum().y();
137  double yc = oldgtp.position().y() - qob * oldgtp.momentum().x();
138 
139  // and of course....
140  double npx = (newpt.y() - yc) * (bz / oldgtp.charge());
141  double npy = (xc - newpt.x()) * (bz / oldgtp.charge());
142 
143  /*
144  * old code: slow and wrong
145  *
146  // now we do a translation, move the center of circle to (0,0,0).
147  double dx1 = oldgtp.position().x() - xc;
148  double dy1 = oldgtp.position().y() - yc;
149  double dx2 = newpt.x() - xc;
150  double dy2 = newpt.y() - yc;
151 
152  // now for the angles:
153  double cosphi = ( dx1 * dx2 + dy1 * dy2 ) /
154  ( sqrt ( dx1 * dx1 + dy1 * dy1 ) * sqrt ( dx2 * dx2 + dy2 * dy2 ));
155  double sinphi = - oldgtp.charge() * sqrt ( 1 - cosphi * cosphi );
156 
157  // Finally, the new momenta:
158  double px = cosphi * oldgtp.momentum().x() - sinphi * oldgtp.momentum().y();
159  double py = sinphi * oldgtp.momentum().x() + cosphi * oldgtp.momentum().y();
160 
161  std::cout << px-npx << " " << py-npy << ", " << oldgtp.charge() << std::endl;
162  */
163 
164  GlobalVector vta(npx, npy, oldgtp.momentum().z());
165  GlobalTrajectoryParameters gta(newpt, vta, oldgtp.charge(), &(oldgtp.magneticField()));
166  return gta;
167 }

References GlobalTrajectoryParameters::charge(), GlobalTrajectoryParameters::magneticField(), GlobalTrajectoryParameters::momentum(), GlobalTrajectoryParameters::position(), PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), and PV3DBase< T, PVType, FrameType >::z().

◆ points()

pair< GlobalPoint, GlobalPoint > ClosestApproachInRPhi::points ( ) const
overridevirtual

Returns the two PCA on the trajectories.

Implements ClosestApproachOnHelices.

Definition at line 38 of file ClosestApproachInRPhi.cc.

38  {
39  if (!status_)
40  throw cms::Exception(
41  "TrackingTools/PatternTools",
42  "ClosestApproachInRPhi::could not compute track crossing. Check status before calling this method!");
43  return pair<GlobalPoint, GlobalPoint>(posA, posB);
44 }

References Exception.

◆ status()

bool ClosestApproachInRPhi::status ( void  ) const
inlineoverridevirtual

◆ trajectoryParameters()

pair< GlobalTrajectoryParameters, GlobalTrajectoryParameters > ClosestApproachInRPhi::trajectoryParameters ( ) const

Returns not only the points, but the full GlobalTrajectoryParemeters at the points of closest approach

Definition at line 121 of file ClosestApproachInRPhi.cc.

121  {
122  if (!status_)
123  throw cms::Exception(
124  "TrackingTools/PatternTools",
125  "ClosestApproachInRPhi::could not compute track crossing. Check status before calling this method!");
126  pair<GlobalTrajectoryParameters, GlobalTrajectoryParameters> ret(newTrajectory(posA, paramA, bz),
128  return ret;
129 }

References Exception, and runTheMatrix::ret.

◆ transverseCoord()

int ClosestApproachInRPhi::transverseCoord ( double  cxa,
double  cya,
double  ra,
double  cxb,
double  cyb,
double  rb,
double &  xg1,
double &  yg1,
double &  xg2,
double &  yg2 
)
staticprivate

Definition at line 197 of file ClosestApproachInRPhi.cc.

206  {
207  int flag = 0;
208  double x1, y1, x2, y2;
209 
210  // new reference frame with origin in (cxa, cya) and x-axis
211  // directed from (cxa, cya) to (cxb, cyb)
212 
213  double d_ab = sqrt((cxb - cxa) * (cxb - cxa) + (cyb - cya) * (cyb - cya));
214  if (d_ab == 0) { // concentric circles
215  return 0;
216  }
217  // elements of rotation matrix
218  double u = (cxb - cxa) / d_ab;
219  double v = (cyb - cya) / d_ab;
220 
221  // conditions for circle intersection
222  if (d_ab <= ra + rb && d_ab >= abs(rb - ra)) {
223  // circles cross each other
224  flag = 1;
225 
226  // triangle (ra, rb, d_ab)
227  double cosphi = (ra * ra - rb * rb + d_ab * d_ab) / (2 * ra * d_ab);
228  double sinphi2 = 1. - cosphi * cosphi;
229  if (sinphi2 < 0.) {
230  sinphi2 = 0.;
231  cosphi = 1.;
232  }
233 
234  // intersection points in new frame
235  double sinphi = sqrt(sinphi2);
236  x1 = ra * cosphi;
237  y1 = ra * sinphi;
238  x2 = x1;
239  y2 = -y1;
240  } else if (d_ab > ra + rb) {
241  // circles are external to each other
242  flag = 2;
243 
244  // points of closest approach in new frame
245  // are on line between 2 centers
246  x1 = ra;
247  y1 = 0;
248  x2 = d_ab - rb;
249  y2 = 0;
250  } else if (d_ab < abs(rb - ra)) {
251  // circles are inside each other
252  flag = 2;
253 
254  // points of closest approach in new frame are on line between 2 centers
255  // choose 2 closest points
256  double sign = 1.;
257  if (ra <= rb)
258  sign = -1.;
259  x1 = sign * ra;
260  y1 = 0;
261  x2 = d_ab + sign * rb;
262  y2 = 0;
263  } else {
264  return 0;
265  }
266 
267  // intersection points in global frame, transverse plane
268  xg1 = u * x1 - v * y1 + cxa;
269  yg1 = v * x1 + u * y1 + cya;
270  xg2 = u * x2 - v * y2 + cxa;
271  yg2 = v * x2 + u * y2 + cya;
272 
273  return flag;
274 }

References funct::abs(), RemoveAddSevLevel::flag, Validation_hcalonly_cfi::sign, mathSSE::sqrt(), findQualityFiles::v, testProducerWithPsetDescEmpty_cfi::x1, testProducerWithPsetDescEmpty_cfi::x2, testProducerWithPsetDescEmpty_cfi::y1, and testProducerWithPsetDescEmpty_cfi::y2.

◆ zCoord()

double ClosestApproachInRPhi::zCoord ( const GlobalVector mom,
const GlobalPoint pos,
double  r,
double  xc,
double  yc,
double  xg,
double  yg 
)
staticprivate

Definition at line 276 of file ClosestApproachInRPhi.cc.

277  {
278  // starting point
279  double x = pos.x();
280  double y = pos.y();
281  double z = pos.z();
282 
283  double px = mom.x();
284  double py = mom.y();
285  double pz = mom.z();
286 
287  // rotation angle phi from starting point to crossing point (absolute value)
288  // -- compute sin(phi/2) if phi smaller than pi/4,
289  // -- cos(phi) if phi larger than pi/4
290  double phi = 0.;
291  double sinHalfPhi = sqrt((x - xg) * (x - xg) + (y - yg) * (y - yg)) / (2 * r);
292  if (sinHalfPhi < 0.383) { // sin(pi/8)
293  phi = 2 * asin(sinHalfPhi);
294  } else {
295  double cosPhi = ((x - xc) * (xg - xc) + (y - yc) * (yg - yc)) / (r * r);
296  if (std::abs(cosPhi) > 1)
297  cosPhi = (cosPhi > 0 ? 1 : -1);
298  phi = abs(acos(cosPhi));
299  }
300  // -- sign of phi
301  double signPhi = ((x - xc) * (yg - yc) - (xg - xc) * (y - yc) > 0) ? 1. : -1.;
302 
303  // sign of track angular momentum
304  // if rotation is along angular momentum, delta z is along pz
305  double signOmega = ((x - xc) * py - (y - yc) * px > 0) ? 1. : -1.;
306 
307  // delta z
308  // -- |dz| = |cos(theta) * path along helix|
309  // = |cos(theta) * arc length along circle / sin(theta)|
310  double dz = signPhi * signOmega * (pz / mom.transverse()) * phi * r;
311 
312  return z + dz;
313 }

References funct::abs(), PVValHelper::dz, multPhiCorr_741_25nsDY_cfi::px, multPhiCorr_741_25nsDY_cfi::py, alignCSCRings::r, mathSSE::sqrt(), PV3DBase< T, PVType, FrameType >::transverse(), PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), and PV3DBase< T, PVType, FrameType >::z().

Friends And Related Function Documentation

◆ test::ClosestApproachInRPhi_t::test

Member Data Documentation

◆ bz

double ClosestApproachInRPhi::bz
private

Definition at line 114 of file ClosestApproachInRPhi.h.

◆ paramA

GlobalTrajectoryParameters ClosestApproachInRPhi::paramA
private

Definition at line 113 of file ClosestApproachInRPhi.h.

◆ paramB

GlobalTrajectoryParameters ClosestApproachInRPhi::paramB
private

Definition at line 113 of file ClosestApproachInRPhi.h.

◆ posA

GlobalPoint ClosestApproachInRPhi::posA
private

Definition at line 112 of file ClosestApproachInRPhi.h.

◆ posB

GlobalPoint ClosestApproachInRPhi::posB
private

Definition at line 112 of file ClosestApproachInRPhi.h.

◆ status_

bool ClosestApproachInRPhi::status_
private

Definition at line 115 of file ClosestApproachInRPhi.h.

Referenced by ClosestApproachInRPhi(), and status().

Vector3DBase
Definition: Vector3DBase.h:8
runTheMatrix.ret
ret
prodAgent to be discontinued
Definition: runTheMatrix.py:542
FreeTrajectoryState::momentum
GlobalVector momentum() const
Definition: FreeTrajectoryState.h:68
DDAxes::y
MagneticField::inTesla
virtual GlobalVector inTesla(const GlobalPoint &gp) const =0
Field value ad specified global point, in Tesla.
TrackCharge
int TrackCharge
Definition: TrackCharge.h:4
ClosestApproachInRPhi::circleParameters
static void circleParameters(const TrackCharge &charge, const GlobalVector &momemtum, const GlobalPoint &position, double &xc, double &yc, double &r, double bz)
Definition: ClosestApproachInRPhi.cc:169
PV3DBase::x
T x() const
Definition: PV3DBase.h:59
multPhiCorr_741_25nsDY_cfi.py
py
Definition: multPhiCorr_741_25nsDY_cfi.py:12
ClosestApproachInRPhi::transverseCoord
static int transverseCoord(double cxa, double cya, double ra, double cxb, double cyb, double rb, double &xg1, double &yg1, double &xg2, double &yg2)
Definition: ClosestApproachInRPhi.cc:197
testProducerWithPsetDescEmpty_cfi.x2
x2
Definition: testProducerWithPsetDescEmpty_cfi.py:28
TrajectoryStateOnSurface::globalPosition
GlobalPoint globalPosition() const
Definition: TrajectoryStateOnSurface.h:65
pos
Definition: PixelAliasList.h:18
FreeTrajectoryState::charge
TrackCharge charge() const
Definition: FreeTrajectoryState.h:69
TrajectoryStateOnSurface::charge
TrackCharge charge() const
Definition: TrajectoryStateOnSurface.h:68
ClosestApproachInRPhi::compute
bool compute(const TrackCharge &chargeA, const GlobalVector &momentumA, const GlobalPoint &positionA, const TrackCharge &chargeB, const GlobalVector &momentumB, const GlobalPoint &positionB)
Definition: ClosestApproachInRPhi.cc:62
Validation_hcalonly_cfi.sign
sign
Definition: Validation_hcalonly_cfi.py:32
ClosestApproachInRPhi::ClosestApproachInRPhi
ClosestApproachInRPhi()
Definition: ClosestApproachInRPhi.h:30
DDAxes::x
FreeTrajectoryState::position
GlobalPoint position() const
Definition: FreeTrajectoryState.h:67
findQualityFiles.v
v
Definition: findQualityFiles.py:179
PV3DBase::z
T z() const
Definition: PV3DBase.h:61
testProducerWithPsetDescEmpty_cfi.x1
x1
Definition: testProducerWithPsetDescEmpty_cfi.py:33
testProducerWithPsetDescEmpty_cfi.y1
y1
Definition: testProducerWithPsetDescEmpty_cfi.py:29
TrajectoryStateOnSurface::freeState
FreeTrajectoryState const * freeState(bool withErrors=true) const
Definition: TrajectoryStateOnSurface.h:58
mathSSE::sqrt
T sqrt(T t)
Definition: SSEVec.h:19
DDAxes::z
ClosestApproachInRPhi::status_
bool status_
Definition: ClosestApproachInRPhi.h:115
GlobalTrajectoryParameters
Definition: GlobalTrajectoryParameters.h:15
GlobalPoint
Global3DPoint GlobalPoint
Definition: GlobalPoint.h:10
Point3DBase< float, GlobalTag >
ClosestApproachInRPhi::paramB
GlobalTrajectoryParameters paramB
Definition: ClosestApproachInRPhi.h:113
ALCARECOTkAlJpsiMuMu_cff.charge
charge
Definition: ALCARECOTkAlJpsiMuMu_cff.py:47
testProducerWithPsetDescEmpty_cfi.y2
y2
Definition: testProducerWithPsetDescEmpty_cfi.py:30
ClosestApproachInRPhi::zCoord
static double zCoord(const GlobalVector &mom, const GlobalPoint &pos, double r, double xc, double yc, double xg, double yg)
Definition: ClosestApproachInRPhi.cc:276
ClosestApproachInRPhi::bz
double bz
Definition: ClosestApproachInRPhi.h:114
position
static int position[264][3]
Definition: ReadPGInfo.cc:289
PV3DBase::y
T y() const
Definition: PV3DBase.h:60
FreeTrajectoryState::parameters
const GlobalTrajectoryParameters & parameters() const
Definition: FreeTrajectoryState.h:79
ClosestApproachInRPhi::newTrajectory
static GlobalTrajectoryParameters newTrajectory(const GlobalPoint &newpt, const GlobalTrajectoryParameters &oldpar, double bz)
Definition: ClosestApproachInRPhi.cc:131
ClosestApproachInRPhi::paramA
GlobalTrajectoryParameters paramA
Definition: ClosestApproachInRPhi.h:113
PV3DBase::basicVector
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:53
alignCSCRings.r
r
Definition: alignCSCRings.py:93
DDAxes::phi
multPhiCorr_741_25nsDY_cfi.px
px
Definition: multPhiCorr_741_25nsDY_cfi.py:10
TrajectoryStateOnSurface::globalMomentum
GlobalVector globalMomentum() const
Definition: TrajectoryStateOnSurface.h:66
PVValHelper::dz
Definition: PVValidationHelpers.h:51
Exception
Definition: hltDiff.cc:245
ClosestApproachInRPhi::posB
GlobalPoint posB
Definition: ClosestApproachInRPhi.h:112
GlobalTrajectoryParameters::magneticField
const MagneticField & magneticField() const
Definition: GlobalTrajectoryParameters.h:106
funct::abs
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
TrajectoryStateOnSurface::globalParameters
const GlobalTrajectoryParameters & globalParameters() const
Definition: TrajectoryStateOnSurface.h:64
ClosestApproachInRPhi::posA
GlobalPoint posA
Definition: ClosestApproachInRPhi.h:112
PV3DBase::transverse
T transverse() const
Definition: PV3DBase.h:70
RemoveAddSevLevel.flag
flag
Definition: RemoveAddSevLevel.py:116