35 float dx = GetX() - t.GetX();
36 float dy = GetY() - t.GetY();
37 float dz = GetZ() - t.GetZ();
38 return dx * dx + dy * dy + dz * dz;
45 float dx = GetX() - t.GetX();
46 float dz = GetZ() - t.GetZ();
47 return dx * dx + dz * dz;
54 float k = GetKappa(Bz);
55 float ex = GetCosPhi();
56 float ey = GetSinPhi();
59 float dS =
x * ex +
y * ey;
60 if (CAMath::Abs(k) > 1.e-4f) {
61 dS = CAMath::ATan2(k * dS, 1 + k * (
x * ey -
y * ex)) / k;
72 float k = GetKappa(Bz);
73 float ex = GetCosPhi();
74 float ey = GetSinPhi();
77 float ax = dx * k + ey;
78 float ay = dy * k - ex;
79 float a = CAMath::Sqrt(ax * ax + ay * ay);
80 xp =
x0 + (dx - ey * ((dx * dx + dy * dy) * k - 2 * (-dx * ey + dy * ex)) / (
a + 1)) /
a;
81 yp =
y0 + (dy + ex * ((dx * dx + dy * dy) * k - 2 * (-dx * ey + dy * ex)) / (
a + 1)) /
a;
82 float s = GetS(
x,
y, Bz);
83 zp = GetZ() + GetDzDs() *
s;
84 if (CAMath::Abs(k) > 1.e-2f) {
85 float dZ = CAMath::Abs(GetDzDs() * CAMath::TwoPi() / k);
87 zp += CAMath::Round((
z - zp) / dZ) * dZ;
104 float ex =
t0.CosPhi();
105 float ey =
t0.SinPhi();
106 float k = -
t0.QPt() * Bz;
109 float ey1 = k * dx + ey;
114 if (CAMath::Abs(ey1) > maxSinPhi) {
118 ex1 = CAMath::Sqrt(1 - ey1 * ey1);
127 if (CAMath::Abs(
cc) < 1.e-4f || CAMath::Abs(ex) < 1.e-4f || CAMath::Abs(ex1) < 1.e-4f) {
134 float dl = dx * CAMath::Sqrt(1 + tg * tg);
139 float dSin = dl * k / 2;
146 float dS = (CAMath::Abs(k) > 1.e-4f) ? (2 * CAMath::ASin(dSin) / k) : dl;
147 float dz = dS *
t0.DzDs();
150 *DL = -dS * CAMath::Sqrt(1 +
t0.DzDs() *
t0.DzDs());
153 float cci = 1.f /
cc;
154 float exi = 1.f / ex;
155 float ex1i = 1.f / ex1;
157 float d[5] = {0, 0, GetPar(2) -
t0.SinPhi(), GetPar(3) -
t0.DzDs(), GetPar(4) -
t0.QPt()};
165 float h2 = dx * (1 + ey * ey1 + ex * ex1) * exi * ex1i * cci;
166 float h4 = dx2 * (
cc + ss * ey1 * ex1i) * cci * cci * (-Bz);
167 float dxBz = dx * (-Bz);
173 SetPar(0, Y() + dy + h2 * d[2] + h4 * d[4]);
174 SetPar(1, Z() + dz + dS * d[3]);
175 SetPar(2,
t0.SinPhi() + d[2] + dxBz * d[4]);
177 float c00 = mParam.mC[0];
178 float c10 = mParam.mC[1];
179 float c11 = mParam.mC[2];
180 float c20 = mParam.mC[3];
181 float c21 = mParam.mC[4];
182 float c22 = mParam.mC[5];
183 float c30 = mParam.mC[6];
184 float c31 = mParam.mC[7];
185 float c32 = mParam.mC[8];
186 float c33 = mParam.mC[9];
187 float c40 = mParam.mC[10];
188 float c41 = mParam.mC[11];
189 float c42 = mParam.mC[12];
190 float c43 = mParam.mC[13];
191 float c44 = mParam.mC[14];
193 mParam.mC[0] = c00 + h2 * h2 * c22 + h4 * h4 * c44 + 2 * (h2 * c20 + h4 * c40 + h2 * h4 * c42);
195 mParam.mC[1] = c10 + h2 * c21 + h4 * c41 + dS * (c30 + h2 * c32 + h4 * c43);
196 mParam.mC[2] = c11 + 2 * dS * c31 + dS * dS * c33;
198 mParam.mC[3] = c20 + h2 * c22 + h4 * c42 + dxBz * (c40 + h2 * c42 + h4 * c44);
199 mParam.mC[4] = c21 + dS * c32 + dxBz * (c41 + dS * c43);
200 mParam.mC[5] = c22 + 2 * dxBz * c42 + dxBz * dxBz * c44;
202 mParam.mC[6] = c30 + h2 * c32 + h4 * c43;
203 mParam.mC[7] = c31 + dS * c33;
204 mParam.mC[8] = c32 + dxBz * c43;
207 mParam.mC[10] = c40 + h2 * c42 + h4 * c44;
208 mParam.mC[11] = c41 + dS * c43;
209 mParam.mC[12] = c42 + dxBz * c44;
216GPUd() bool
GPUTPCTrackParam::TransportToX(
float x,
float sinPhi0,
float cosPhi0,
float Bz,
float maxSinPhi)
229 if (CAMath::Abs(ex) < 1.e-4f) {
232 float exi = 1.f / ex;
234 float dxBz = dx * (-Bz);
236 float h2 = dS * exi * exi;
237 float h4 = .5f * h2 * dxBz;
245 float sinPhi = SinPhi() + dxBz * QPt();
246 if (maxSinPhi > 0 && CAMath::Abs(sinPhi) > maxSinPhi) {
251 SetPar(0, GetPar(0) + dS * ey + h2 * (SinPhi() - ey) + h4 * QPt());
252 SetPar(1, GetPar(1) + dS * DzDs());
255 float c00 = mParam.mC[0];
256 float c10 = mParam.mC[1];
257 float c11 = mParam.mC[2];
258 float c20 = mParam.mC[3];
259 float c21 = mParam.mC[4];
260 float c22 = mParam.mC[5];
261 float c30 = mParam.mC[6];
262 float c31 = mParam.mC[7];
263 float c32 = mParam.mC[8];
264 float c33 = mParam.mC[9];
265 float c40 = mParam.mC[10];
266 float c41 = mParam.mC[11];
267 float c42 = mParam.mC[12];
268 float c43 = mParam.mC[13];
269 float c44 = mParam.mC[14];
273 mParam.mC[0] = CAMath::Max(c00, c00 + h2 * h2 * c22 + h4 * h4 * c44 + 2 * (h2 * c20 + h4 * c40 + h2 * h4 * c42));
275 mParam.mC[1] = c10 + h2 * c21 + h4 * c41 + dS * (c30 + h2 * c32 + h4 * c43);
276 mParam.mC[2] = CAMath::Max(c11, c11 + 2 * dS * c31 + dS * dS * c33);
278 mParam.mC[3] = c20 + h2 * c22 + h4 * c42 + dxBz * (c40 + h2 * c42 + h4 * c44);
279 mParam.mC[4] = c21 + dS * c32 + dxBz * (c41 + dS * c43);
280 mParam.mC[5] = c22 + 2 * dxBz * c42 + dxBz * dxBz * c44;
282 mParam.mC[6] = c30 + h2 * c32 + h4 * c43;
283 mParam.mC[7] = c31 + dS * c33;
284 mParam.mC[8] = c32 + dxBz * c43;
287 mParam.mC[10] = c40 + h2 * c42 + h4 * c44;
288 mParam.mC[11] = c41 + dS * c43;
289 mParam.mC[12] = c42 + dxBz * c44;
300 return TransportToX(
x,
t0, Bz, maxSinPhi);
307 static constexpr float kRho = 1.025e-3f;
308 static constexpr float kRadLen = 28811.7f;
310 static constexpr float kRadLenInv = 1.f / kRadLen;
313 if (!TransportToX(
x,
t0, Bz, maxSinPhi, &dl)) {
317 CorrectForMeanMaterial(dl * kRadLenInv, dl * kRho, par);
326 return TransportToXWithMaterial(
x,
t0, par, Bz, maxSinPhi);
333 GPUTPCTrackFitParam par;
334 CalculateFitParameters(par);
335 return TransportToXWithMaterial(
x, par, Bz, maxSinPhi);
341GPUd() float
GPUTPCTrackParam::BetheBlochGeant(
float bg2,
float kp0,
float kp1,
float kp2,
float kp3,
float kp4)
357 const float mK = 0.307075e-3f;
358 const float me = 0.511e-3f;
359 const float rho = kp0;
360 const float x0 =
kp1 * 2.303f;
361 const float x1 =
kp2 * 2.303f;
362 const float mI =
kp3;
363 const float mZA =
kp4;
368 const float x = 0.5f * CAMath::Log(bg2);
369 const float lhwI = CAMath::Log(28.816f * 1e-9f * CAMath::Sqrt(rho * mZA) / mI);
373 const float r = (
x1 -
x) / (
x1 -
x0);
377 return mK * mZA * (1 +
bg2) / bg2 * (0.5f * CAMath::Log(2 * me * bg2 * maxT / (mI * mI)) - bg2 / (1 + bg2) -
d2);
389 return BetheBlochGeant(bg);
401 const float rho = 0.9e-3f;
402 const float x0 = 2.f;
403 const float x1 = 4.f;
404 const float mI = 140.e-9f;
405 const float mZA = 0.49555f;
407 return BetheBlochGeant(bg, rho,
x0,
x1, mI, mZA);
421 if (beta2 / (1 - beta2) > 3.5f * 3.5f) {
422 return 0.153e-3f /
beta2 * (CAMath::Log(3.5f * 5940) + 0.5f * CAMath::Log(beta2 / (1 - beta2)) -
beta2);
424 return 0.153e-3f /
beta2 * (CAMath::Log(5940 * beta2 / (1 - beta2)) -
beta2);
431 float qpt = GetPar(4);
432 if (mParam.mC[14] >= 1.f) {
436 float p2 = (1.f + GetPar(3) * GetPar(3));
437 float k2 = qpt * qpt;
438 float mass2 = mass * mass;
441 float pp2 = (k2 > 1.e-8f) ?
p2 / k2 : 10000;
444 par.bethe = ApproximateBetheBloch(pp2 / mass2);
445 par.e = CAMath::Sqrt(pp2 + mass2);
446 par.theta2 = 14.1f * 14.1f / (
beta2 * pp2 * 1e6f);
447 par.EP2 = par.e / pp2;
451 const float knst = 0.0007f;
452 par.sigmadE2 = knst * par.EP2 * qpt;
453 par.sigmadE2 = par.sigmadE2 * par.sigmadE2;
455 par.k22 = (1.f + GetPar(3) * GetPar(3));
456 par.k33 = par.k22 * par.k22;
458 par.k44 = GetPar(3) * GetPar(3) * k2;
461GPUd() bool
GPUTPCTrackParam::CorrectForMeanMaterial(
float xOverX0,
float xTimesRho, const GPUTPCTrackFitParam& par)
469 float& mC22 = mParam.mC[5];
470 float& mC33 = mParam.mC[9];
471 float& mC40 = mParam.mC[10];
472 float& mC41 = mParam.mC[11];
473 float& mC42 = mParam.mC[12];
474 float& mC43 = mParam.mC[13];
475 float& mC44 = mParam.mC[14];
479 float dE = par.bethe * xTimesRho;
480 if (CAMath::Abs(dE) > 0.3f * par.e) {
483 float corr = (1.f - par.EP2 * dE);
484 if (corr < 0.3f || corr > 1.3f) {
488 SetPar(4, GetPar(4) * corr);
494 mC44 += par.sigmadE2 * CAMath::Abs(dE);
498 float theta2 = par.theta2 * CAMath::Abs(xOverX0);
499 mC22 += theta2 * par.k22 * (1.f - GetPar(2)) * (1.f + GetPar(2));
500 mC33 += theta2 * par.k33;
501 mC43 += theta2 * par.k43;
502 mC44 += theta2 * par.k44;
514 float cA = CAMath::Cos(
alpha);
515 float sA = CAMath::Sin(
alpha);
516 float x = X(),
y = Y(), sP = SinPhi(), cP = GetCosPhi();
517 float cosPhi = cP * cA + sP * sA;
518 float sinPhi = -cP * sA + sP * cA;
520 if (CAMath::Abs(sinPhi) > maxSinPhi || CAMath::Abs(cosPhi) < 1.e-2f || CAMath::Abs(cP) < 1.e-2f) {
524 float j0 = cP / cosPhi;
525 float j2 = cosPhi / cP;
527 SetX(
x * cA +
y * sA);
528 SetY(-
x * sA +
y * cA);
529 SetSignCosPhi(cosPhi);
539 mParam.mC[0] *= j0 * j0;
547 mParam.mC[5] *= j2 * j2;
552 SetSinPhi(-SinPhi());
555 mParam.mC[3] = -mParam.mC[3];
556 mParam.mC[4] = -mParam.mC[4];
557 mParam.mC[6] = -mParam.mC[6];
558 mParam.mC[7] = -mParam.mC[7];
559 mParam.mC[10] = -mParam.mC[10];
560 mParam.mC[11] = -mParam.mC[11];
571 float cA = CAMath::Cos(
alpha);
572 float sA = CAMath::Sin(
alpha);
573 float x0 = X(),
y0 = Y(), sP =
t0.SinPhi(), cP =
t0.CosPhi();
574 float cosPhi = cP * cA + sP * sA;
575 float sinPhi = -cP * sA + sP * cA;
577 if (CAMath::Abs(sinPhi) > maxSinPhi || CAMath::Abs(cosPhi) < 1.e-2f || CAMath::Abs(cP) < 1.e-2f) {
587 float j0 = cP / cosPhi;
588 float j2 = cosPhi / cP;
589 float d[2] = {Y() -
y0, SinPhi() - sP};
591 SetX(
x0 * cA +
y0 * sA);
592 SetY(-
x0 * sA +
y0 * cA + j0 * d[0]);
593 t0.SetCosPhi(cosPhi);
594 t0.SetSinPhi(sinPhi);
596 SetSinPhi(sinPhi + j2 * d[1]);
598 mParam.mC[0] *= j0 * j0;
606 mParam.mC[5] *= j2 * j2;
613GPUd() bool
GPUTPCTrackParam::Filter(
float y,
float z,
float err2Y,
float err2Z,
float maxSinPhi,
bool paramOnly)
617 float c00 = mParam.mC[0], c11 = mParam.mC[2], c20 = mParam.mC[3], c31 = mParam.mC[7], c40 = mParam.mC[10];
622 float z0 =
y - GetPar(0),
z1 =
z - GetPar(1);
624 if (err2Y < 1.e-8f || err2Z < 1.e-8f) {
628 float mS0 = 1.f / err2Y;
629 float mS2 = 1.f / err2Z;
633 float k00, k11, k20, k31, k40;
642 float sinPhi = GetPar(2) + k20 * z0;
644 if (maxSinPhi > 0 && CAMath::Abs(sinPhi) >= maxSinPhi) {
648 SetPar(0, GetPar(0) + k00 * z0);
649 SetPar(1, GetPar(1) + k11 * z1);
651 SetPar(3, GetPar(3) + k31 * z1);
652 SetPar(4, GetPar(4) + k40 * z0);
658 mChi2 += mS0 * z0 * z0 + mS2 *
z1 *
z1;
660 mParam.mC[0] -= k00 * c00;
661 mParam.mC[3] -= k20 * c00;
662 mParam.mC[5] -= k20 * c20;
663 mParam.mC[10] -= k40 * c00;
664 mParam.mC[12] -= k40 * c20;
665 mParam.mC[14] -= k40 * c40;
667 mParam.mC[2] -= k11 * c11;
668 mParam.mC[7] -= k31 * c11;
669 mParam.mC[9] -= k31 * c31;
678 bool ok = CAMath::Finite(GetX()) && CAMath::Finite(mSignCosPhi) && CAMath::Finite(mChi2);
680 const float*
c = Cov();
681 for (int32_t
i = 0;
i < 15;
i++) {
682 ok = ok && CAMath::Finite(
c[
i]);
684 for (int32_t
i = 0;
i < 5;
i++) {
685 ok = ok && CAMath::Finite(Par()[
i]);
688 if (
c[0] <= 0 ||
c[2] <= 0 ||
c[5] <= 0 ||
c[9] <= 0 ||
c[14] <= 0) {
691 if (
c[0] > 5.f ||
c[2] > 5.f ||
c[5] > 2.f ||
c[9] > 2
700 if (CAMath::Abs(QPt()) > 1.f / 0.05f) {
704 ok = ok && (
c[1] *
c[1] <=
c[2] *
c[0]) && (
c[3] *
c[3] <=
c[5] *
c[0]) && (
c[4] *
c[4] <=
c[5] *
c[2]) && (
c[6] *
c[6] <=
c[9] *
c[0]) && (
c[7] *
c[7] <=
c[9] *
c[2]) && (
c[8] *
c[8] <=
c[9] *
c[5]) && (
c[10] *
c[10] <=
c[14] *
c[0]) && (
c[11] *
c[11] <=
c[14] *
c[2]) &&
705 (
c[12] *
c[12] <=
c[14] *
c[5]) && (
c[13] *
c[13] <=
c[14] *
c[9]);
714 mParam.mZOffset +=
z;
719 }
else if (
z > GPUTPCGeometry::TPCLength()) {
720 float shift =
z - GPUTPCGeometry::TPCLength();
721 mParam.mZOffset += shift;
722 mParam.mP[1] -= shift;
725 z = GPUTPCGeometry::TPCLength();
729 mParam.mZOffset +=
z;
734 }
else if (
z < -GPUTPCGeometry::TPCLength()) {
735 float shift = -GPUTPCGeometry::TPCLength() -
z;
736 mParam.mZOffset -= shift;
737 mParam.mP[1] += shift;
740 z = -GPUTPCGeometry::TPCLength();
747 const float r1 = CAMath::Max(0.0001f, CAMath::Abs(mParam.mP[4] * bz));
749 const float dist2 = mParam.mX * mParam.mX + mParam.mP[0] * mParam.mP[0];
750 const float dist1r2 = dist2 * r1 * r1;
752 bool beamlineReached =
false;
754 const float alpha = CAMath::ACos(1 - 0.5f * dist1r2);
755 const float beta = CAMath::ATan2(mParam.mP[0], mParam.mX);
756 const int32_t comp = mParam.mP[2] > CAMath::Sin(beta);
757 const float sinab = CAMath::Sin((comp ? 0.5f : -0.5f) *
alpha + beta);
758 const float res = CAMath::Abs(sinab - mParam.mP[2]);
761 const float r = 1.f / r1;
762 const float dS =
alpha *
r;
763 float z0 = dS * mParam.mP[3];
764 if (CAMath::Abs(z0) > GPUTPCGeometry::TPCLength()) {
765 z0 = z0 > 0 ? GPUTPCGeometry::TPCLength() : -
GPUTPCGeometry::TPCLength();
767 deltaZ = mParam.mP[1] - z0;
768 beamlineReached =
true;
772 if (!beamlineReached) {
774 if (CAMath::Abs(z1) < CAMath::Abs(z2)) {
781 float refZ = ((basez > 0) ? defaultZOffsetOverR : -defaultZOffsetOverR) * basex;
782 deltaZ = basez - refZ - mParam.mZOffset;
784 mParam.mZOffset += deltaZ;
785 mParam.mP[1] -= deltaZ;
787 float zMax = CAMath::Max(z1, z2);
788 float zMin = CAMath::Min(z1, z2);
789 if (
zMin < 0 &&
zMin - mParam.mZOffset < -GPUTPCGeometry::TPCLength()) {
790 deltaZ =
zMin - mParam.mZOffset + GPUTPCGeometry::TPCLength();
791 }
else if (
zMax > 0 &&
zMax - mParam.mZOffset > GPUTPCGeometry::TPCLength()) {
792 deltaZ =
zMax - mParam.mZOffset - GPUTPCGeometry::TPCLength();
794 if (
zMin < 0 &&
zMax - (mParam.mZOffset + deltaZ) > 0) {
795 deltaZ =
zMax - mParam.mZOffset;
796 }
else if (
zMax > 0 &&
zMin - (mParam.mZOffset + deltaZ) < 0) {
797 deltaZ =
zMin - mParam.mZOffset;
799 mParam.mZOffset += deltaZ;
800 mParam.mP[1] -= deltaZ;
803#if !defined(GPUCA_GPUCODE)
811#if !defined(GPUCA_GPUCODE)
812 std::cout <<
"track: x=" << GetX() <<
" c=" << GetSignCosPhi() <<
", P= " << GetY() <<
" " << GetZ() <<
" " << GetSinPhi() <<
" " << GetDzDs() <<
" " << GetQPt() << std::endl;
813 std::cout <<
"errs2: " << Err2Y() <<
" " << Err2Z() <<
" " << Err2SinPhi() <<
" " << Err2DzDs() <<
" " << Err2QPt() << std::endl;
819 float k = mParam.mP[4] * bz;
820 float dx =
x - mParam.mX;
821 float ey = mParam.mP[2];
822 float ex = CAMath::Sqrt(1 - ey * ey);
823 if (SignCosPhi() < 0) {
826 float ey1 = ey - k * dx;
831 float ex1 = CAMath::Sqrt(1.f - ey1 * ey1);
832 if (SignCosPhi() < 0) {
836 float dxcci = dx /
cc;
837 float dy = dxcci * ss;
838 float norm2 = 1.f + ey * ey1 + ex * ex1;
839 float dl = dxcci * CAMath::Sqrt(norm2 + norm2);
842 float dSin = 0.5f * k * dl;
843 float a = dSin * dSin;
844 const float k2 = 1.f / 6.f;
845 const float k4 = 3.f / 40.f;
846 dS = dl + dl *
a * (k2 +
a * (k4));
848 float dz = dS * mParam.mP[3];
849 projY = mParam.mP[0] + dy;
850 projZ = mParam.mP[1] + dz;
#define GPUCA_MAX_SIN_PHI
GPUd() float GPUTPCTrackParam
GLfloat GLfloat GLfloat alpha
GLuint GLfloat GLfloat GLfloat x1
typedef void(APIENTRYP PFNGLCULLFACEPROC)(GLenum mode)
GLuint GLfloat GLfloat GLfloat GLfloat GLfloat GLfloat GLfloat t0
GLboolean GLboolean GLboolean GLboolean a
GLuint GLfloat GLfloat y0
GLdouble GLdouble GLdouble z
const float3 float float x2
float float float float float z2
float float float float z1
std::vector< o2::mch::ChannelCode > cc