]> git.uio.no Git - u/mrichter/AliRoot.git/blame - ITS/AliITStrackV2.cxx
Reducing verbosity
[u/mrichter/AliRoot.git] / ITS / AliITStrackV2.cxx
CommitLineData
006b5f7f 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 **************************************************************************/
15
ae00569a 16/* $Id$ */
17
66e811e2 18///////////////////////////////////////////////////////////////////////////
006b5f7f 19// Implementation of the ITS track class
20//
21// Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
a9a2d814 22// dEdx analysis by: Boris Batyunya, JINR, Boris.Batiounia@cern.ch
66e811e2 23///////////////////////////////////////////////////////////////////////////
006b5f7f 24#include <TMath.h>
006b5f7f 25
26#include "AliCluster.h"
83d73500 27#include "AliESDtrack.h"
58e536c5 28#include "AliESDVertex.h"
8a84886c 29#include "AliITSReconstructor.h"
006b5f7f 30#include "AliITStrackV2.h"
f7a1cc68 31#include "AliTracker.h"
006b5f7f 32
8602c008 33const Int_t AliITStrackV2::fgkWARN = 5;
34
1aedd96e 35ClassImp(AliITStrackV2)
8676d691 36
e43c066c 37
22b13da0 38//____________________________________________________________________________
6c94f330 39AliITStrackV2::AliITStrackV2() : AliKalmanTrack(),
22b13da0 40 fdEdx(0),
83d73500 41 fESDtrack(0)
e43c066c 42{
ae00569a 43 for(Int_t i=0; i<2*AliITSgeomTGeo::kNLayers; i++) {fIndex[i]=-1; fModule[i]=-1;}
44 for(Int_t i=0; i<4; i++) fdEdxSample[i]=0;
e43c066c 45}
46
83d73500 47
83d73500 48//____________________________________________________________________________
67c3dcbe 49AliITStrackV2::AliITStrackV2(AliESDtrack& t,Bool_t c) throw (const Char_t *) :
6c94f330 50 AliKalmanTrack(),
51 fdEdx(t.GetITSsignal()),
52 fESDtrack(&t)
53{
83d73500 54 //------------------------------------------------------------------
67c3dcbe 55 // Conversion ESD track -> ITS track.
56 // If c==kTRUE, create the ITS track out of the constrained params.
83d73500 57 //------------------------------------------------------------------
6c94f330 58 const AliExternalTrackParam *par=&t;
59 if (c) {
6c4ef2ed 60 par=t.GetConstrainedParam();
6c94f330 61 if (!par) throw "AliITStrackV2: conversion failed !\n";
62 }
63 Set(par->GetX(),par->GetAlpha(),par->GetParameter(),par->GetCovariance());
64
65 //if (!Invariant()) throw "AliITStrackV2: conversion failed !\n";
66
83d73500 67 SetLabel(t.GetLabel());
68 SetMass(t.GetMass());
6c94f330 69 SetNumberOfClusters(t.GetITSclusters(fIndex));
006b5f7f 70
83d73500 71 if (t.GetStatus()&AliESDtrack::kTIME) {
72 StartTimeIntegral();
73 Double_t times[10]; t.GetIntegratedTimes(times); SetIntegratedTimes(times);
74 SetIntegratedLength(t.GetIntegratedLength());
75 }
e43c066c 76
68b8060b 77 for(Int_t i=0; i<4; i++) fdEdxSample[i]=0;
006b5f7f 78}
79
7ac23097 80//____________________________________________________________________________
81void AliITStrackV2::ResetClusters() {
82 //------------------------------------------------------------------
83 // Reset the array of attached clusters.
84 //------------------------------------------------------------------
85 for (Int_t i=0; i<2*AliITSgeomTGeo::kNLayers; i++) fIndex[i]=-1;
86 SetChi2(0.);
87 SetNumberOfClusters(0);
88}
89
09cf9d66 90//____________________________________________________________________________
15dd636f 91void AliITStrackV2::UpdateESDtrack(ULong_t flags) const {
09cf9d66 92 // Update track params
83d73500 93 fESDtrack->UpdateTrackParams(this,flags);
ae00569a 94 // copy the module indices
95 for(Int_t i=0;i<12;i++) {
96 // printf(" %d\n",GetModuleIndex(i));
97 fESDtrack->SetITSModuleIndex(i,GetModuleIndex(i));
98 }
09cf9d66 99 // copy the 4 dedx samples
100 Double_t sdedx[4]={0.,0.,0.,0.};
101 for(Int_t i=0; i<4; i++) sdedx[i]=fdEdxSample[i];
102 fESDtrack->SetITSdEdxSamples(sdedx);
83d73500 103}
104
006b5f7f 105//____________________________________________________________________________
6c94f330 106AliITStrackV2::AliITStrackV2(const AliITStrackV2& t) :
107 AliKalmanTrack(t),
108 fdEdx(t.fdEdx),
109 fESDtrack(t.fESDtrack)
110{
006b5f7f 111 //------------------------------------------------------------------
112 //Copy constructor
113 //------------------------------------------------------------------
ef7253ac 114 Int_t i;
ef7253ac 115 for (i=0; i<4; i++) fdEdxSample[i]=t.fdEdxSample[i];
ae00569a 116 for (i=0; i<2*AliITSgeomTGeo::GetNLayers(); i++) {
117 fIndex[i]=t.fIndex[i];
118 fModule[i]=t.fModule[i];
119 }
006b5f7f 120}
a9a2d814 121
006b5f7f 122//_____________________________________________________________________________
123Int_t AliITStrackV2::Compare(const TObject *o) const {
124 //-----------------------------------------------------------------
125 // This function compares tracks according to the their curvature
126 //-----------------------------------------------------------------
7f6ddf58 127 AliITStrackV2 *t=(AliITStrackV2*)o;
6c23ffed 128 //Double_t co=OneOverPt();
129 //Double_t c =OneOverPt();
15dd636f 130 Double_t co=t->GetSigmaY2()*t->GetSigmaZ2();
131 Double_t c =GetSigmaY2()*GetSigmaZ2();
006b5f7f 132 if (c>co) return 1;
133 else if (c<co) return -1;
134 return 0;
135}
136
006b5f7f 137//____________________________________________________________________________
6c94f330 138Bool_t
139AliITStrackV2::PropagateToVertex(const AliESDVertex *v,Double_t d,Double_t x0)
140{
006b5f7f 141 //------------------------------------------------------------------
142 //This function propagates a track to the minimal distance from the origin
6c94f330 143 //------------------------------------------------------------------
144 Double_t bz=GetBz();
e50912db 145 if (PropagateToDCA(v,bz,kVeryBig)) {
146 Double_t xOverX0,xTimesRho;
147 xOverX0 = d; xTimesRho = d*x0;
148 if (CorrectForMeanMaterial(xOverX0,xTimesRho,kTRUE)) return kTRUE;
149 }
6c94f330 150 return kFALSE;
006b5f7f 151}
152
153//____________________________________________________________________________
6c94f330 154Bool_t AliITStrackV2::
e50912db 155GetGlobalXYZat(Double_t xloc, Double_t &x, Double_t &y, Double_t &z) const {
006b5f7f 156 //------------------------------------------------------------------
157 //This function returns a track position in the global system
158 //------------------------------------------------------------------
6c94f330 159 Double_t r[3];
f7a1cc68 160 Bool_t rc=GetXYZAt(xloc, GetBz(), r);
6c94f330 161 x=r[0]; y=r[1]; z=r[2];
162 return rc;
006b5f7f 163}
164
165//_____________________________________________________________________________
6c94f330 166Double_t AliITStrackV2::GetPredictedChi2(const AliCluster *c) const {
006b5f7f 167 //-----------------------------------------------------------------
168 // This function calculates a predicted chi2 increment.
169 //-----------------------------------------------------------------
6c94f330 170 Double_t p[2]={c->GetY(), c->GetZ()};
171 Double_t cov[3]={c->GetSigmaY2(), 0., c->GetSigmaZ2()};
172 return AliExternalTrackParam::GetPredictedChi2(p,cov);
a9a2d814 173}
174
175//____________________________________________________________________________
6c94f330 176Bool_t AliITStrackV2::PropagateTo(Double_t xk, Double_t d, Double_t x0) {
006b5f7f 177 //------------------------------------------------------------------
178 //This function propagates a track
179 //------------------------------------------------------------------
afd25725 180
6c94f330 181 Double_t oldX=GetX(), oldY=GetY(), oldZ=GetZ();
006b5f7f 182
1defa402 183 //Double_t bz=GetBz();
184 //if (!AliExternalTrackParam::PropagateTo(xk,bz)) return kFALSE;
185 Double_t b[3]; GetBxByBz(b);
186 if (!AliExternalTrackParam::PropagateToBxByBz(xk,b)) return kFALSE;
e50912db 187 Double_t xOverX0,xTimesRho;
188 xOverX0 = d; xTimesRho = d*x0;
189 if (!CorrectForMeanMaterial(xOverX0,xTimesRho,kTRUE)) return kFALSE;
006b5f7f 190
dd44614b 191 Double_t x=GetX(), y=GetY(), z=GetZ();
6c94f330 192 if (IsStartedTimeIntegral() && x>oldX) {
193 Double_t l2 = (x-oldX)*(x-oldX) + (y-oldY)*(y-oldY) + (z-oldZ)*(z-oldZ);
f29dbb4b 194 AddTimeStep(TMath::Sqrt(l2));
195 }
f29dbb4b 196
6c94f330 197 return kTRUE;
006b5f7f 198}
199
afd25725 200//____________________________________________________________________________
db355ee7 201Bool_t AliITStrackV2::PropagateToTGeo(Double_t xToGo, Int_t nstep, Double_t &xOverX0, Double_t &xTimesRho, Bool_t addTime) {
afd25725 202 //-------------------------------------------------------------------
203 // Propagates the track to a reference plane x=xToGo in n steps.
204 // These n steps are only used to take into account the curvature.
205 // The material is calculated with TGeo. (L.Gaudichet)
206 //-------------------------------------------------------------------
207
208 Double_t startx = GetX(), starty = GetY(), startz = GetZ();
209 Double_t sign = (startx<xToGo) ? -1.:1.;
210 Double_t step = (xToGo-startx)/TMath::Abs(nstep);
211
1defa402 212 Double_t start[3], end[3], mparam[7];
213 //Double_t bz = GetBz();
214 Double_t b[3]; GetBxByBz(b);
215 Double_t bz = b[2];
216
afd25725 217 Double_t x = startx;
218
219 for (Int_t i=0; i<nstep; i++) {
220
221 GetXYZ(start); //starting global position
222 x += step;
223 if (!GetXYZAt(x, bz, end)) return kFALSE;
1defa402 224 //if (!AliExternalTrackParam::PropagateTo(x, bz)) return kFALSE;
225 if (!AliExternalTrackParam::PropagateToBxByBz(x, b)) return kFALSE;
afd25725 226 AliTracker::MeanMaterialBudget(start, end, mparam);
8fc9f3dc 227 xTimesRho = sign*mparam[4]*mparam[0];
228 xOverX0 = mparam[1];
afd25725 229 if (mparam[1]<900000) {
afd25725 230 if (!AliExternalTrackParam::CorrectForMeanMaterial(xOverX0,
8fc9f3dc 231 xTimesRho,GetMass())) return kFALSE;
232 } else { // this happens when MeanMaterialBudget cannot cross a boundary
233 return kFALSE;
afd25725 234 }
235 }
236
db355ee7 237 if (addTime && IsStartedTimeIntegral() && GetX()>startx) {
afd25725 238 Double_t l2 = ( (GetX()-startx)*(GetX()-startx) +
239 (GetY()-starty)*(GetY()-starty) +
240 (GetZ()-startz)*(GetZ()-startz) );
241 AddTimeStep(TMath::Sqrt(l2));
242 }
243
244 return kTRUE;
245}
246
006b5f7f 247//____________________________________________________________________________
6c94f330 248Bool_t AliITStrackV2::Update(const AliCluster* c, Double_t chi2, Int_t index)
249{
006b5f7f 250 //------------------------------------------------------------------
251 //This function updates track parameters
252 //------------------------------------------------------------------
6c94f330 253 Double_t p[2]={c->GetY(), c->GetZ()};
d9ead1a0 254 Double_t cov[3]={c->GetSigmaY2(), c->GetSigmaYZ(), c->GetSigmaZ2()};
006b5f7f 255
6c94f330 256 if (!AliExternalTrackParam::Update(p,cov)) return kFALSE;
006b5f7f 257
28d5b13d 258 Int_t n=GetNumberOfClusters();
006b5f7f 259 if (!Invariant()) {
28d5b13d 260 if (n>fgkWARN) AliWarning("Wrong invariant !");
6c94f330 261 return kFALSE;
006b5f7f 262 }
263
6c94f330 264 if (chi2<0) return kTRUE;
67c3dcbe 265
b5205c90 266 // fill residuals for ITS+TPC tracks
badb951a 267 if (fESDtrack) {
268 if (fESDtrack->GetStatus()&AliESDtrack::kTPCin) {
269 AliTracker::FillResiduals(this,p,cov,c->GetVolumeId());
270 }
b5205c90 271 }
150f264c 272
006b5f7f 273 fIndex[n]=index;
274 SetNumberOfClusters(n+1);
275 SetChi2(GetChi2()+chi2);
276
6c94f330 277 return kTRUE;
006b5f7f 278}
279
6c94f330 280Bool_t AliITStrackV2::Invariant() const {
006b5f7f 281 //------------------------------------------------------------------
282 // This function is for debugging purpose only
283 //------------------------------------------------------------------
7f6ddf58 284 Int_t n=GetNumberOfClusters();
6c94f330 285
8a84886c 286 // take into account the misalignment error
287 Float_t maxMisalErrY2=0,maxMisalErrZ2=0;
288 for (Int_t lay=0; lay<AliITSgeomTGeo::kNLayers; lay++) {
d9ead1a0 289 maxMisalErrY2 = TMath::Max(maxMisalErrY2,AliITSReconstructor::GetRecoParam()->GetClusterMisalErrorY(lay,GetBz()));
290 maxMisalErrZ2 = TMath::Max(maxMisalErrZ2,AliITSReconstructor::GetRecoParam()->GetClusterMisalErrorZ(lay,GetBz()));
8a84886c 291 }
292 maxMisalErrY2 *= maxMisalErrY2;
293 maxMisalErrZ2 *= maxMisalErrZ2;
294 // this is because when we reset before refitting, we multiply the
295 // matrix by 10
296 maxMisalErrY2 *= 10.;
297 maxMisalErrZ2 *= 10.;
298
6c94f330 299 Double_t sP2=GetParameter()[2];
300 if (TMath::Abs(sP2) >= kAlmost1){
8602c008 301 if (n>fgkWARN) Warning("Invariant","fP2=%f\n",sP2);
6c94f330 302 return kFALSE;
a9a2d814 303 }
6c94f330 304 Double_t sC00=GetCovariance()[0];
8a84886c 305 if (sC00<=0 || sC00>(9.+maxMisalErrY2)) {
8602c008 306 if (n>fgkWARN) Warning("Invariant","fC00=%f\n",sC00);
6c94f330 307 return kFALSE;
a9a2d814 308 }
6c94f330 309 Double_t sC11=GetCovariance()[2];
8a84886c 310 if (sC11<=0 || sC11>(9.+maxMisalErrZ2)) {
8602c008 311 if (n>fgkWARN) Warning("Invariant","fC11=%f\n",sC11);
6c94f330 312 return kFALSE;
a9a2d814 313 }
6c94f330 314 Double_t sC22=GetCovariance()[5];
315 if (sC22<=0 || sC22>1.) {
8602c008 316 if (n>fgkWARN) Warning("Invariant","fC22=%f\n",sC22);
6c94f330 317 return kFALSE;
a9a2d814 318 }
6c94f330 319 Double_t sC33=GetCovariance()[9];
320 if (sC33<=0 || sC33>1.) {
8602c008 321 if (n>fgkWARN) Warning("Invariant","fC33=%f\n",sC33);
6c94f330 322 return kFALSE;
a9a2d814 323 }
6c94f330 324 Double_t sC44=GetCovariance()[14];
325 if (sC44<=0 /*|| sC44>6e-5*/) {
8602c008 326 if (n>fgkWARN) Warning("Invariant","fC44=%f\n",sC44);
6c94f330 327 return kFALSE;
14825d5a 328 }
6c94f330 329
330 return kTRUE;
006b5f7f 331}
332
333//____________________________________________________________________________
6c94f330 334Bool_t AliITStrackV2::Propagate(Double_t alp,Double_t xk) {
006b5f7f 335 //------------------------------------------------------------------
336 //This function propagates a track
337 //------------------------------------------------------------------
1defa402 338 //Double_t bz=GetBz();
339 //if (!AliExternalTrackParam::Propagate(alp,xk,bz)) return kFALSE;
340 Double_t b[3]; GetBxByBz(b);
341 if (!AliExternalTrackParam::PropagateBxByBz(alp,xk,b)) return kFALSE;
006b5f7f 342
006b5f7f 343 if (!Invariant()) {
8a84886c 344 Int_t n=GetNumberOfClusters();
345 if (n>fgkWARN) AliWarning("Wrong invariant !");
346 return kFALSE;
791f9a2a 347 }
348
6c94f330 349 return kTRUE;
a9a2d814 350}
006b5f7f 351
afd25725 352Bool_t AliITStrackV2::MeanBudgetToPrimVertex(Double_t xyz[3], Double_t step, Double_t &d) const {
353
354 //-------------------------------------------------------------------
355 // Get the mean material budget between the actual point and the
356 // primary vertex. (L.Gaudichet)
357 //-------------------------------------------------------------------
358
359 Double_t cs=TMath::Cos(GetAlpha()), sn=TMath::Sin(GetAlpha());
360 Double_t vertexX = xyz[0]*cs + xyz[1]*sn;
361
362 Int_t nstep = Int_t((GetX()-vertexX)/step);
363 if (nstep<1) nstep = 1;
364 step = (GetX()-vertexX)/nstep;
365
c7719399 366 // Double_t mparam[7], densMean=0, radLength=0, length=0;
367 Double_t mparam[7];
afd25725 368 Double_t p1[3], p2[3], x = GetX(), bz = GetBz();
369 GetXYZ(p1);
370
371 d=0.;
372
373 for (Int_t i=0; i<nstep; i++) {
374 x += step;
375 if (!GetXYZAt(x, bz, p2)) return kFALSE;
376 AliTracker::MeanMaterialBudget(p1, p2, mparam);
377 if (mparam[1]>900000) return kFALSE;
378 d += mparam[1];
379
380 p1[0] = p2[0];
381 p1[1] = p2[1];
382 p1[2] = p2[2];
383 }
384
385 return kTRUE;
386}
387
6c94f330 388Bool_t AliITStrackV2::Improve(Double_t x0,Double_t xyz[3],Double_t ers[3]) {
babd135a 389 //------------------------------------------------------------------
6c94f330 390 //This function improves angular track parameters
babd135a 391 //------------------------------------------------------------------
6c94f330 392 Double_t cs=TMath::Cos(GetAlpha()), sn=TMath::Sin(GetAlpha());
393//Double_t xv = xyz[0]*cs + xyz[1]*sn; // vertex
394 Double_t yv =-xyz[0]*sn + xyz[1]*cs; // in the
395 Double_t zv = xyz[2]; // local frame
babd135a 396
6c94f330 397 Double_t dy = Par(0) - yv, dz = Par(1) - zv;
398 Double_t r2=GetX()*GetX() + dy*dy;
6c23ffed 399 Double_t p2=(1.+ GetTgl()*GetTgl())/(GetSigned1Pt()*GetSigned1Pt());
a9a2d814 400 Double_t beta2=p2/(p2 + GetMass()*GetMass());
401 x0*=TMath::Sqrt((1.+ GetTgl()*GetTgl())/(1.- GetSnp()*GetSnp()));
8676d691 402 Double_t theta2=14.1*14.1/(beta2*p2*1e6)*x0;
403 //Double_t theta2=1.0259e-6*14*14/28/(beta2*p2)*x0*9.36*2.33;
6c94f330 404
405 Double_t cnv=GetBz()*kB2C;
a9a2d814 406 {
6c94f330 407 Double_t dummy = 4/r2 - GetC()*GetC();
408 if (dummy < 0) return kFALSE;
409 Double_t parp = 0.5*(GetC()*GetX() + dy*TMath::Sqrt(dummy));
bfd20868 410 Double_t sigma2p = theta2*(1.-GetSnp())*(1.+GetSnp())*(1. + GetTgl()*GetTgl());
411 Double_t ovSqr2 = 1./TMath::Sqrt(r2);
412 Double_t tfact = ovSqr2*(1.-dy*ovSqr2)*(1.+dy*ovSqr2);
413 sigma2p += Cov(0)*tfact*tfact;
6c94f330 414 sigma2p += ers[1]*ers[1]/r2;
415 sigma2p += 0.25*Cov(14)*cnv*cnv*GetX()*GetX();
00709873 416 Double_t eps2p=sigma2p/(Cov(5) + sigma2p);
6c94f330 417 Par(0) += Cov(3)/(Cov(5) + sigma2p)*(parp - GetSnp());
418 Par(2) = eps2p*GetSnp() + (1 - eps2p)*parp;
419 Cov(5) *= eps2p;
420 Cov(3) *= eps2p;
a9a2d814 421 }
422 {
6c94f330 423 Double_t parl=0.5*GetC()*dz/TMath::ASin(0.5*GetC()*TMath::Sqrt(r2));
424 Double_t sigma2l=theta2;
425 sigma2l += Cov(2)/r2 + Cov(0)*dy*dy*dz*dz/(r2*r2*r2);
426 sigma2l += ers[2]*ers[2]/r2;
427 Double_t eps2l = sigma2l/(Cov(9) + sigma2l);
428 Par(1) += Cov(7 )/(Cov(9) + sigma2l)*(parl - Par(3));
429 Par(4) += Cov(13)/(Cov(9) + sigma2l)*(parl - Par(3));
430 Par(3) = eps2l*Par(3) + (1-eps2l)*parl;
431 Cov(9) *= eps2l;
00709873 432 Cov(13)*= eps2l;
6c94f330 433 Cov(7) *= eps2l;
a9a2d814 434 }
6c94f330 435 if (!Invariant()) return kFALSE;
14825d5a 436
6c94f330 437 return kTRUE;
14825d5a 438}
23efe5f1 439
440void AliITStrackV2::CookdEdx(Double_t low, Double_t up) {
441 //-----------------------------------------------------------------
a9a2d814 442 // This function calculates dE/dX within the "low" and "up" cuts.
443 // Origin: Boris Batyunya, JINR, Boris.Batiounia@cern.ch
09cf9d66 444 // Updated: F. Prino 8-June-2009
23efe5f1 445 //-----------------------------------------------------------------
09cf9d66 446 // The cluster order is: SDD-1, SDD-2, SSD-1, SSD-2
c0dd5278 447
c0dd5278 448 Int_t nc=0;
09cf9d66 449 Float_t dedx[4];
450 for (Int_t il=0; il<4; il++) { // count good (>0) dE/dx values
451 if(fdEdxSample[il]>0.){
452 dedx[nc]= fdEdxSample[il];
453 nc++;
454 }
455 }
456 if(nc<1){
457 SetdEdx(0.);
458 return;
c0dd5278 459 }
23efe5f1 460
09cf9d66 461 Int_t swap; // sort in ascending order
23efe5f1 462 do {
463 swap=0;
09cf9d66 464 for (Int_t i=0; i<nc-1; i++) {
465 if (dedx[i]<=dedx[i+1]) continue;
466 Float_t tmp=dedx[i];
467 dedx[i]=dedx[i+1];
468 dedx[i+1]=tmp;
23efe5f1 469 swap++;
470 }
471 } while (swap);
472
23efe5f1 473
09cf9d66 474 Double_t nl=low*nc, nu =up*nc;
475 Float_t sumamp = 0;
476 Float_t sumweight =0;
477 for (Int_t i=0; i<nc; i++) {
478 Float_t weight =1;
479 if (i<nl+0.1) weight = TMath::Max(1.-(nl-i),0.);
480 if (i>nu-1) weight = TMath::Max(nu-i,0.);
481 sumamp+= dedx[i]*weight;
482 sumweight+=weight;
483 }
484 SetdEdx(sumamp/sumweight);
23efe5f1 485}
c7bafca9 486
8602c008 487//____________________________________________________________________________
488Bool_t AliITStrackV2::
e50912db 489GetPhiZat(Double_t r, Double_t &phi, Double_t &z) const {
490 //------------------------------------------------------------------
491 // This function returns the global cylindrical (phi,z) of the track
492 // position estimated at the radius r.
493 // The track curvature is neglected.
494 //------------------------------------------------------------------
495 Double_t d=GetD(0.,0.);
bc02d571 496 if (TMath::Abs(d) > r) {
497 if (r>1e-1) return kFALSE;
498 r = TMath::Abs(d);
499 }
e50912db 500
501 Double_t rcurr=TMath::Sqrt(GetX()*GetX() + GetY()*GetY());
494a930c 502 if (TMath::Abs(d) > rcurr) return kFALSE;
503 Double_t globXYZcurr[3]; GetXYZ(globXYZcurr);
504 Double_t phicurr=TMath::ATan2(globXYZcurr[1],globXYZcurr[0]);
e50912db 505
2089d338 506 if (GetX()>=0.) {
507 phi=phicurr+TMath::ASin(d/r)-TMath::ASin(d/rcurr);
508 } else {
509 phi=phicurr+TMath::ASin(d/r)+TMath::ASin(d/rcurr)-TMath::Pi();
510 }
511
494a930c 512 // return a phi in [0,2pi[
513 if (phi<0.) phi+=2.*TMath::Pi();
514 else if (phi>=2.*TMath::Pi()) phi-=2.*TMath::Pi();
c7de5c65 515 z=GetZ()+GetTgl()*(TMath::Sqrt((r-d)*(r+d))-TMath::Sqrt((rcurr-d)*(rcurr+d)));
e50912db 516 return kTRUE;
517}
518//____________________________________________________________________________
519Bool_t AliITStrackV2::
520GetLocalXat(Double_t r,Double_t &xloc) const {
8602c008 521 //------------------------------------------------------------------
e50912db 522 // This function returns the local x of the track
523 // position estimated at the radius r.
8602c008 524 // The track curvature is neglected.
525 //------------------------------------------------------------------
526 Double_t d=GetD(0.,0.);
6a14afad 527 if (TMath::Abs(d) > r) {
528 if (r>1e-1) return kFALSE;
529 r = TMath::Abs(d);
530 }
8602c008 531
e50912db 532 Double_t rcurr=TMath::Sqrt(GetX()*GetX() + GetY()*GetY());
494a930c 533 Double_t globXYZcurr[3]; GetXYZ(globXYZcurr);
534 Double_t phicurr=TMath::ATan2(globXYZcurr[1],globXYZcurr[0]);
2089d338 535 Double_t phi;
536 if (GetX()>=0.) {
537 phi=phicurr+TMath::ASin(d/r)-TMath::ASin(d/rcurr);
538 } else {
539 phi=phicurr+TMath::ASin(d/r)+TMath::ASin(d/rcurr)-TMath::Pi();
540 }
8602c008 541
e50912db 542 xloc=r*(TMath::Cos(phi)*TMath::Cos(GetAlpha())
543 +TMath::Sin(phi)*TMath::Sin(GetAlpha()));
8602c008 544
545 return kTRUE;
546}