]> git.uio.no Git - u/mrichter/AliRoot.git/blame - TOF/AliTOFtrack.cxx
Removing wrong inline from the implementation file
[u/mrichter/AliRoot.git] / TOF / AliTOFtrack.cxx
CommitLineData
74ea065c 1/**************************************************************************
2 * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
3 * *
4 * Author: The ALICE Off-line Project. *
5 * Contributors are mentioned in the code where appropriate. *
6 * *
7 * Permission to use, copy, modify and distribute this software and its *
8 * documentation strictly for non-commercial purposes is hereby granted *
9 * without fee, provided that the above copyright notice appears in all *
10 * copies and that both the copyright notice and this permission notice *
11 * appear in the supporting documentation. The authors make no claims *
12 * about the suitability of this software for any purpose. It is *
13 * provided "as is" without express or implied warranty. *
14 **************************************************************************/
2c770f53 15////////////////////////////////////////////////////////////////////////
16//
17// AliTOFtrack class
18//
19// Authors: Bologna-CERN-ITEP-Salerno Group
20//
21// Description: class for handling ESD extracted tracks for TOF matching.
74ea065c 22/* $Id$ */
23
24#include <Riostream.h>
d3c7bfac 25
74ea065c 26#include <TObject.h>
d3c7bfac 27
d076c8d5 28#include "AliLog.h"
74ea065c 29#include "AliESDtrack.h"
30
d3c7bfac 31#include "AliTOFGeometry.h"
32#include "AliTOFGeometryV4.h"
33#include "AliTOFGeometryV5.h"
34#include "AliTOFtrack.h"
35
74ea065c 36ClassImp(AliTOFtrack)
37
38//_____________________________________________________________________________
39AliTOFtrack::AliTOFtrack(const AliTOFtrack& t) : AliKalmanTrack(t) {
40 //
41 // Copy constructor.
42 //
43
44 SetSeedIndex(t.GetSeedIndex());
45 SetLabel(t.GetLabel());
46 fSeedLab=t.GetSeedLabel();
47 SetChi2(t.GetChi2());
48
49 fAlpha=t.fAlpha;
50 fX=t.fX;
51
52 fY=t.fY; fZ=t.fZ; fE=t.fE; fT=t.fT; fC=t.fC;
53
54 fCyy=t.fCyy;
55 fCzy=t.fCzy; fCzz=t.fCzz;
56 fCey=t.fCey; fCez=t.fCez; fCee=t.fCee;
57 fCty=t.fCty; fCtz=t.fCtz; fCte=t.fCte; fCtt=t.fCtt;
58 fCcy=t.fCcy; fCcz=t.fCcz; fCce=t.fCce; fCct=t.fCct; fCcc=t.fCcc;
59
d3c7bfac 60 fTOFgeometry = new AliTOFGeometryV4();
74ea065c 61
62}
63
64//_____________________________________________________________________________
65AliTOFtrack::AliTOFtrack(const AliESDtrack& t)
66 :AliKalmanTrack() {
67 //
68 // Constructor from AliESDtrack
69 //
70
d3c7bfac 71 fTOFgeometry = new AliTOFGeometryV4();
72
74ea065c 73 SetSeedIndex(-1);
74 SetLabel(t.GetLabel());
75 SetChi2(0.);
76 SetMass(t.GetMass());
77
78 fAlpha = t.GetAlpha();
79 if (fAlpha < -TMath::Pi()) fAlpha += 2*TMath::Pi();
80 else if (fAlpha >= TMath::Pi()) fAlpha -= 2*TMath::Pi();
81 Double_t x, p[5]; t.GetExternalParameters(x,p);
82
83 fX=x;
84
74ea065c 85 fY=p[0];
c84a5e9e 86 fZ=p[1]; SaveLocalConvConst();
87 fT=p[3]; x=GetLocalConvConst();
74ea065c 88 fC=p[4]/x;
89 fE=fC*fX - p[2];
90
91 //Conversion of the covariance matrix
92 Double_t c[15]; t.GetExternalCovariance(c);
93
94 c[10]/=x; c[11]/=x; c[12]/=x; c[13]/=x; c[14]/=x*x;
95
96 Double_t c22=fX*fX*c[14] - 2*fX*c[12] + c[5];
97 Double_t c32=fX*c[13] - c[8];
98 Double_t c20=fX*c[10] - c[3], c21=fX*c[11] - c[4], c42=fX*c[14] - c[12];
99
100 fCyy=c[0 ];
101 fCzy=c[1 ]; fCzz=c[2 ];
102 fCey=c20; fCez=c21; fCee=c22;
103 fCty=c[6 ]; fCtz=c[7 ]; fCte=c32; fCtt=c[9 ];
104 fCcy=c[10]; fCcz=c[11]; fCce=c42; fCct=c[13]; fCcc=c[14];
105
106 if ((t.GetStatus()&AliESDtrack::kTIME) == 0) return;
107 StartTimeIntegral();
108 Double_t times[10]; t.GetIntegratedTimes(times); SetIntegratedTimes(times);
109 SetIntegratedLength(t.GetIntegratedLength());
110
111
112}
113//____________________________________________________________________________
114void AliTOFtrack::GetExternalParameters(Double_t& xr, Double_t x[5]) const {
115 //
116 // This function returns external TOF track representation
117 //
118 xr=fX;
119 x[0]=GetY();
120 x[1]=GetZ();
121 x[2]=GetSnp();
122 x[3]=GetTgl();
123 x[4]=Get1Pt();
124}
125
126//_____________________________________________________________________________
127void AliTOFtrack::GetExternalCovariance(Double_t cc[15]) const {
128 //
129 // This function returns external representation of the covriance matrix.
130 //
c84a5e9e 131 Double_t a=GetLocalConvConst();
74ea065c 132 Double_t c22=fX*fX*fCcc-2*fX*fCce+fCee;
133 Double_t c32=fX*fCct-fCte;
134 Double_t c20=fX*fCcy-fCey, c21=fX*fCcz-fCez, c42=fX*fCcc-fCce;
135
136 cc[0 ]=fCyy;
137 cc[1 ]=fCzy; cc[2 ]=fCzz;
138 cc[3 ]=c20; cc[4 ]=c21; cc[5 ]=c22;
139 cc[6 ]=fCty; cc[7 ]=fCtz; cc[8 ]=c32; cc[9 ]=fCtt;
140 cc[10]=fCcy*a; cc[11]=fCcz*a; cc[12]=c42*a; cc[13]=fCct*a; cc[14]=fCcc*a*a;
141
142}
143
144
145//_____________________________________________________________________________
146void AliTOFtrack::GetCovariance(Double_t cc[15]) const {
2c770f53 147 //
148 // Returns the covariance matrix.
149 //
74ea065c 150
151 cc[0]=fCyy;
152 cc[1]=fCzy; cc[2]=fCzz;
153 cc[3]=fCey; cc[4]=fCez; cc[5]=fCee;
154 cc[6]=fCcy; cc[7]=fCcz; cc[8]=fCce; cc[9]=fCcc;
155 cc[10]=fCty; cc[11]=fCtz; cc[12]=fCte; cc[13]=fCct; cc[14]=fCtt;
156
157}
158
159
160//_____________________________________________________________________________
161Int_t AliTOFtrack::PropagateTo(Double_t xk,Double_t x0,Double_t rho)
162{
163 // Propagates a track of particle with mass=pm to a reference plane
164 // defined by x=xk through media of density=rho and radiationLength=x0
165
166 if (xk == fX) return 1;
167
168 if (TMath::Abs(fC*xk - fE) >= 0.90000) {
169 return 0;
170 }
c84a5e9e 171 Double_t lcc=GetLocalConvConst();
74ea065c 172
173 // track Length measurement [SR, GSI, 17.02.2003]
174
175 Double_t oldX = fX, oldY = fY, oldZ = fZ;
176
177 Double_t x1=fX, x2=x1+(xk-x1), dx=x2-x1, y1=fY, z1=fZ;
178 Double_t c1=fC*x1 - fE;
179 if((c1*c1) > 1){
180 return 0;}
181 Double_t r1=sqrt(1.- c1*c1);
182 Double_t c2=fC*x2 - fE;
183 if((c2*c2) > 1) {
184 return 0;
185 }
186 Double_t r2=sqrt(1.- c2*c2);
187
188 fY += dx*(c1+c2)/(r1+r2);
189 fZ += dx*(c1+c2)/(c1*r2 + c2*r1)*fT;
190
191 //f = F - 1
192 Double_t rr=r1+r2, cc=c1+c2, xx=x1+x2;
193 Double_t f02=-dx*(2*rr + cc*(c1/r1 + c2/r2))/(rr*rr);
194 Double_t f04= dx*(rr*xx + cc*(c1*x1/r1+c2*x2/r2))/(rr*rr);
195 Double_t cr=c1*r2+c2*r1;
196 Double_t f12=-dx*fT*(2*cr + cc*(c2*c1/r1-r1 + c1*c2/r2-r2))/(cr*cr);
197 Double_t f13= dx*cc/cr;
198 Double_t f14=dx*fT*(cr*xx-cc*(r1*x2-c2*c1*x1/r1+r2*x1-c1*c2*x2/r2))/(cr*cr);
199
200 //b = C*ft
201 Double_t b00=f02*fCey + f04*fCcy, b01=f12*fCey + f14*fCcy + f13*fCty;
202 Double_t b10=f02*fCez + f04*fCcz, b11=f12*fCez + f14*fCcz + f13*fCtz;
203 Double_t b20=f02*fCee + f04*fCce, b21=f12*fCee + f14*fCce + f13*fCte;
204 Double_t b30=f02*fCte + f04*fCct, b31=f12*fCte + f14*fCct + f13*fCtt;
205 Double_t b40=f02*fCce + f04*fCcc, b41=f12*fCce + f14*fCcc + f13*fCct;
206
207 //a = f*b = f*C*ft
208 Double_t a00=f02*b20+f04*b40,a01=f02*b21+f04*b41,a11=f12*b21+f14*b41+f13*b31;
209
210 //F*C*Ft = C + (a + b + bt)
211 fCyy += a00 + 2*b00;
212 fCzy += a01 + b01 + b10;
213 fCey += b20;
214 fCty += b30;
215 fCcy += b40;
216 fCzz += a11 + 2*b11;
217 fCez += b21;
218 fCtz += b31;
219 fCcz += b41;
220
221 fX=x2;
222
c84a5e9e 223 //Change of the magnetic field *************
224 SaveLocalConvConst();
225 cc=fC;
226 fC*=lcc/GetLocalConvConst();
227 fE+=fX*(fC-cc);
228
74ea065c 229 //Multiple scattering ******************
230 Double_t d=sqrt((x1-fX)*(x1-fX)+(y1-fY)*(y1-fY)+(z1-fZ)*(z1-fZ));
231 Double_t p2=(1.+ GetTgl()*GetTgl())/(Get1Pt()*Get1Pt());
232 Double_t beta2=p2/(p2 + GetMass()*GetMass());
233 Double_t theta2=14.1*14.1/(beta2*p2*1e6)*d/x0*rho;
234
235 Double_t ey=fC*fX - fE, ez=fT;
236 Double_t xz=fC*ez, zz1=ez*ez+1, xy=fE+ey;
237
238 fCee += (2*ey*ez*ez*fE+1-ey*ey+ez*ez+fE*fE*ez*ez)*theta2;
239 fCte += ez*zz1*xy*theta2;
240 fCtt += zz1*zz1*theta2;
241 fCce += xz*ez*xy*theta2;
242 fCct += xz*zz1*theta2;
243 fCcc += xz*xz*theta2;
244 /*
245 Double_t dc22 = (1-ey*ey+xz*xz*fX*fX)*theta2;
246 Double_t dc32 = (xz*fX*zz1)*theta2;
247 Double_t dc33 = (zz1*zz1)*theta2;
248 Double_t dc42 = (xz*fX*xz)*theta2;
249 Double_t dc43 = (zz1*xz)*theta2;
250 Double_t dc44 = (xz*xz)*theta2;
251 fCee += dc22;
252 fCte += dc32;
253 fCtt += dc33;
254 fCce += dc42;
255 fCct += dc43;
256 fCcc += dc44;
257 */
258 //Energy losses************************
259 if((5940*beta2/(1-beta2+1e-10) - beta2) < 0){return 0;}
260
261 Double_t dE=0.153e-3/beta2*(log(5940*beta2/(1-beta2+1e-10)) - beta2)*d*rho;
983ebc4f 262 //
263 // suspicious part - think about it ?
264 Double_t kinE = TMath::Sqrt(p2);
265 if (dE>0.8*kinE) dE = 0.8*kinE; //
266 if (dE<0) dE = 0.0; // not valid region for Bethe bloch
267 //
268 //
74ea065c 269 if (x1 < x2) dE=-dE;
270 cc=fC;
271 fC*=(1.- sqrt(p2+GetMass()*GetMass())/p2*dE);
272 fE+=fX*(fC-cc);
273
274 // track time measurement [SR, GSI 17.02.2002]
275 if (x1 < x2)
276 if (IsStartedTimeIntegral()) {
277 Double_t l2 = (fX-oldX)*(fX-oldX) + (fY-oldY)*(fY-oldY) + (fZ-oldZ)*(fZ-oldZ);
278 AddTimeStep(TMath::Sqrt(l2));
279 }
280
281 return 1;
282}
283
284//_____________________________________________________________________________
285Int_t AliTOFtrack::PropagateToInnerTOF( Bool_t holes)
286{
287 // Propagates a track of particle with mass=pm to a reference plane
288 // defined by x=xk through media of density=rho and radiationLength=x0
289
290
d3c7bfac 291 Double_t ymax=fTOFgeometry->RinTOF()*TMath::Tan(0.5*AliTOFGeometry::GetAlpha());
74ea065c 292 Bool_t skip = kFALSE;
d3c7bfac 293 Double_t y=GetYat(fTOFgeometry->RinTOF(),skip);
74ea065c 294 if(skip){
295 return 0;
296 }
297 if (y > ymax) {
2c770f53 298 if (!Rotate(AliTOFGeometry::GetAlpha())) {
74ea065c 299 return 0;
300 }
301 } else if (y <-ymax) {
2c770f53 302 if (!Rotate(-AliTOFGeometry::GetAlpha())) {
74ea065c 303 return 0;
304 }
305 }
306
307
2c770f53 308 Double_t x = GetX();
74ea065c 309 Int_t nsteps=Int_t((370.-x)/0.5); // 0.5 cm Steps
310 for (Int_t istep=0;istep<nsteps;istep++){
311 Float_t xp = x+istep*0.5;
312 Double_t param[2];
2c770f53 313 GetPropagationParameters(holes,param);
314 PropagateTo(xp,param[0],param[1]);
74ea065c 315
316 }
317
d3c7bfac 318 if(!PropagateTo(fTOFgeometry->RinTOF()))return 0;
74ea065c 319
320 return 1;
321
322}
323
324//_____________________________________________________________________________
325Int_t AliTOFtrack::Rotate(Double_t alpha)
326{
327 // Rotates track parameters in R*phi plane
328
329
330 fAlpha += alpha;
331 if (fAlpha<-TMath::Pi()) fAlpha += 2*TMath::Pi();
332 if (fAlpha>=TMath::Pi()) fAlpha -= 2*TMath::Pi();
333
334 Double_t x1=fX, y1=fY;
335 Double_t ca=cos(alpha), sa=sin(alpha);
336 Double_t r1=fC*fX - fE;
337
338 fX = x1*ca + y1*sa;
339 fY =-x1*sa + y1*ca;
340 if((r1*r1) > 1) return 0;
341 fE=fE*ca + (fC*y1 + sqrt(1.- r1*r1))*sa;
342
343 Double_t r2=fC*fX - fE;
344 if (TMath::Abs(r2) >= 0.90000) {
d076c8d5 345 AliWarning("Rotation failed !");
74ea065c 346 return 0;
347 }
348
349 if((r2*r2) > 1) return 0;
350 Double_t y0=fY + sqrt(1.- r2*r2)/fC;
351 if ((fY-y0)*fC >= 0.) {
d076c8d5 352 AliWarning("Rotation failed !!!");
74ea065c 353 return 0;
354 }
355
356 //f = F - 1
357 Double_t f00=ca-1, f24=(y1 - r1*x1/sqrt(1.- r1*r1))*sa,
358 f20=fC*sa, f22=(ca + sa*r1/sqrt(1.- r1*r1))-1;
359
360 //b = C*ft
361 Double_t b00=fCyy*f00, b02=fCyy*f20+fCcy*f24+fCey*f22;
362 Double_t b10=fCzy*f00, b12=fCzy*f20+fCcz*f24+fCez*f22;
363 Double_t b20=fCey*f00, b22=fCey*f20+fCce*f24+fCee*f22;
364 Double_t b30=fCty*f00, b32=fCty*f20+fCct*f24+fCte*f22;
365 Double_t b40=fCcy*f00, b42=fCcy*f20+fCcc*f24+fCce*f22;
366
367 //a = f*b = f*C*ft
368 Double_t a00=f00*b00, a02=f00*b02, a22=f20*b02+f24*b42+f22*b22;
369
370 //F*C*Ft = C + (a + b + bt)
371 fCyy += a00 + 2*b00;
372 fCzy += b10;
373 fCey += a02+b20+b02;
374 fCty += b30;
375 fCcy += b40;
376 fCez += b12;
377 fCte += b32;
378 fCee += a22 + 2*b22;
379 fCce += b42;
380
381 return 1;
382}
383
2c770f53 384//_________________________________________________________________________
4668c628 385Double_t AliTOFtrack::GetYat(Double_t xk, Bool_t & skip) const {
2c770f53 386//-----------------------------------------------------------------
387// This function calculates the Y-coordinate of a track at the plane x=xk.
388// Needed for matching with the TOF (I.Belikov)
389//-----------------------------------------------------------------
390 skip=kFALSE;
391 Double_t c1=fC*fX - fE, r1=TMath::Sqrt(TMath::Abs(1.- c1*c1));
392 Double_t c2=fC*xk - fE, r2=TMath::Sqrt(TMath::Abs(1.- c2*c2));
393 if( ((1.- c2*c2)<0) || ((1.- c1*c1)<0) ) skip=kTRUE;
394 return fY + (xk-fX)*(c1+c2)/(r1+r2);
395}
74ea065c 396//_________________________________________________________________________
397void AliTOFtrack::GetPxPyPz(Double_t& px, Double_t& py, Double_t& pz) const
398{
399 // Returns reconstructed track momentum in the global system.
400
401 Double_t pt=TMath::Abs(GetPt()); // GeV/c
402 Double_t r=fC*fX-fE;
403
404 Double_t y0;
405 if(r > 1) { py = pt; px = 0; }
406 else if(r < -1) { py = -pt; px = 0; }
407 else {
408 y0=fY + sqrt(1.- r*r)/fC;
409 px=-pt*(fY-y0)*fC; //cos(phi);
410 py=-pt*(fE-fX*fC); //sin(phi);
411 }
412 pz=pt*fT;
413 Double_t tmp=px*TMath::Cos(fAlpha) - py*TMath::Sin(fAlpha);
414 py=px*TMath::Sin(fAlpha) + py*TMath::Cos(fAlpha);
415 px=tmp;
416
417}
418
419//_________________________________________________________________________
420void AliTOFtrack::GetGlobalXYZ(Double_t& x, Double_t& y, Double_t& z) const
421{
422 // Returns reconstructed track coordinates in the global system.
423
424 x = fX; y = fY; z = fZ;
425 Double_t tmp=x*TMath::Cos(fAlpha) - y*TMath::Sin(fAlpha);
426 y=x*TMath::Sin(fAlpha) + y*TMath::Cos(fAlpha);
427 x=tmp;
428
429}
430
431//_________________________________________________________________________
432void AliTOFtrack::ResetCovariance() {
433 //
434 // Resets covariance matrix
435 //
436
437 fCyy*=10.;
438 fCzy=0.; fCzz*=10.;
439 fCey=0.; fCez=0.; fCee*=10.;
440 fCty=0.; fCtz=0.; fCte=0.; fCtt*=10.;
441 fCcy=0.; fCcz=0.; fCce=0.; fCct=0.; fCcc*=10.;
442}
443
444
445//_________________________________________________________________________
446void AliTOFtrack::ResetCovariance(Float_t mult) {
447 //
448 // Resets covariance matrix
449 //
450
451 fCyy*=mult;
452 fCzy*=0.; fCzz*=mult;
453 fCey*=0.; fCez*=0.; fCee*=mult;
454 fCty*=0.; fCtz*=0.; fCte*=0.; fCtt*=mult;
455 fCcy*=0.; fCcz*=0.; fCce*=0.; fCct*=0.; fCcc*=mult;
456}
457
458//_____________________________________________________________________________
459Int_t AliTOFtrack::Compare(const TObject *o) const {
460 //-----------------------------------------------------------------
461 // This function compares tracks according to the their curvature
462 //-----------------------------------------------------------------
463 AliTOFtrack *t=(AliTOFtrack*)o;
464 Double_t co=t->GetSigmaY2()*t->GetSigmaZ2();
465 Double_t c =GetSigmaY2()*GetSigmaZ2();
466 if (c>co) return 1;
467 else if (c<co) return -1;
468 return 0;
469}
470
471//_____________________________________________________________________________
472void AliTOFtrack::GetPropagationParameters(Bool_t holes, Double_t *param) {
473
2c770f53 474 //Get average medium density, x0 while propagating the track
475
476 //For TRD holes description
74ea065c 477
478 Double_t thetamin = (90.-31.1) * TMath::Pi()/180.;
479 Double_t thetamax = (90.+31.1) * TMath::Pi()/180.;
480
481 Double_t zmin = -55.;
482 Double_t zmax = 55.;
483
2c770f53 484 // Detector inner/outer radii
74ea065c 485 Double_t rTPC = 261.53;
486 Double_t rTPCTRD = 294.5;
487 Double_t rTRD = 369.1;
488
2c770f53 489 // Medium parameters
74ea065c 490 Double_t x0TPC = 40.;
491 Double_t rhoTPC =0.06124;
492
493 Double_t x0Air = 36.66;
494 Double_t rhoAir =1.2931e-3;
495
496 Double_t x0TRD = 171.7;
497 Double_t rhoTRD =0.33;
498
2c770f53 499 Int_t isec = GetSector();
74ea065c 500 Double_t xtr,ytr,ztr;
2c770f53 501 GetGlobalXYZ(xtr,ytr,ztr);
74ea065c 502 Float_t thetatr = TMath::ATan2(TMath::Sqrt(xtr*xtr+ytr*ytr),ztr);
503
504 if(holes){
505 if (isec == 0 || isec == 1 || isec == 2 ) {
506 if( thetatr>=thetamin && thetatr<=thetamax){
507 x0TRD= x0Air;
508 rhoTRD = rhoAir;
509 }
510 }
511 if (isec == 11 || isec == 12 || isec == 13 || isec == 14 || isec == 15 ) {
512 if( ztr>=zmin && ztr<=zmax){
513 x0TRD= x0Air;
514 rhoTRD = rhoAir;
515 }
516 }
517 }
518
2c770f53 519 if(GetX() <= rTPC)
74ea065c 520 {param[0]=x0TPC;param[1]=rhoTPC;}
2c770f53 521 else if(GetX() > rTPC && GetX() < rTPCTRD)
74ea065c 522 {param[0]=x0Air;param[1]=rhoAir;}
2c770f53 523 else if(GetX() >= rTPCTRD && GetX() < rTRD)
74ea065c 524 {param[0]=x0TRD;param[1]=rhoTRD;}
2c770f53 525 else if(GetX() >= rTRD )
74ea065c 526 {param[0]=x0Air;param[1]=rhoAir;}
74ea065c 527}