]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TRD/AliTRDmcmTracklet.cxx
Coding conventions and minor fixes
[u/mrichter/AliRoot.git] / TRD / AliTRDmcmTracklet.cxx
index 4155d74d51c86e3fd5021841b1adf8d85fa55c27..e895ebcfe0c20f8f9ba7cff12511e4f25e7b65dd 100644 (file)
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
 
+///////////////////////////////////////////////////////
+//                                                   //
+//                                                   //
+//  Tracklet object created in the local tracking    //
+//                                                   //
+//                                                   //
+///////////////////////////////////////////////////////
+
 #include <TGraph.h>
 #include <TMath.h>
 #include <TF1.h>
 
+#include "AliLog.h"
+
 #include "AliTRDcalibDB.h"
 #include "AliTRDCommonParam.h"
 #include "AliTRDpadPlane.h"
 #include "AliTRDgeometry.h"
-
 #include "AliTRDmcmTracklet.h"
 
 ClassImp(AliTRDmcmTracklet)
 
 //_____________________________________________________________________________
 AliTRDmcmTracklet::AliTRDmcmTracklet() 
+  :TObject()
+  ,fGeo(0)
+  ,fDetector(-1)
+  ,fRow(-1)
+  ,fTrackLabel(-1)
+  ,fNclusters(0)
+  ,fN(0)
+  ,fGPos(0)
+  ,fGAmp(0)
+  ,fTime0(0)
+  ,fRowz(0)
+  ,fSlope(0)
+  ,fOffset(0)
+  ,fPt(0)
+  ,fdQdl(0)
 {
-
   //
   // AliTRDmcmTracklet default constructor
   //
 
-  fDetector = -1;
-  fRow      = -1;
+  for (Int_t time = 0; time < kNtimeBins; time++) {
+    for (Int_t icl = 0; icl < kNclsPads; icl++) {
+      fADC[time][icl] = 0;
+    }
+    for (Int_t it = 0; it < kNdict; it++) {
+      fTrack[time][it] = -1;
+    }
+    fTime[time]   = 0;
+    fCol[time]    = 0;
+  }
+
+  fGeo = new AliTRDgeometry();
+
+}
+
+//_____________________________________________________________________________
+AliTRDmcmTracklet::AliTRDmcmTracklet(Int_t det, Int_t row, Int_t n) 
+  :TObject()
+  ,fGeo(0)
+  ,fDetector(det)
+  ,fRow(row)
+  ,fTrackLabel(-1)
+  ,fNclusters(0)
+  ,fN(n)
+  ,fGPos(0)
+  ,fGAmp(0)
+  ,fTime0(0)
+  ,fRowz(0)
+  ,fSlope(0)
+  ,fOffset(0)
+  ,fPt(0)
+  ,fdQdl(0)
+{
+  //
+  // AliTRDmcmTracklet default constructor
+  //
 
   for (Int_t time = 0; time < kNtimeBins; time++) {
     for (Int_t icl = 0; icl < kNclsPads; icl++) {
@@ -48,32 +105,124 @@ AliTRDmcmTracklet::AliTRDmcmTracklet()
     fCol[time]    = 0;
   }
 
-  fNclusters  =  0;
-  fN          =  0;
-  fTrackLabel = -1;
+  fGPos = new TGraph(0);
+  fGAmp = new TGraph(0);
 
-  fGPos = 0;
-  fGAmp = 0;
+  fGeo  = new AliTRDgeometry();
 
-  fSlope  = 0.0;
-  fOffset = 0.0;
-  fTime0  = 0.0;
-  fRowz   = 0.0;
-  fPt     = 0.0;
-  fdQdl   = 0.0;
+}
+
+//_____________________________________________________________________________
+AliTRDmcmTracklet::AliTRDmcmTracklet(const AliTRDmcmTracklet &t) 
+  :TObject(t)
+  ,fGeo(0)
+  ,fDetector(t.fDetector)
+  ,fRow(t.fRow)
+  ,fTrackLabel(t.fTrackLabel)
+  ,fNclusters(t.fNclusters)
+  ,fN(t.fN)
+  ,fGPos(NULL)
+  ,fGAmp(NULL)
+  ,fTime0(t.fTime0)
+  ,fRowz(t.fRowz)
+  ,fSlope(t.fSlope)
+  ,fOffset(t.fOffset)
+  ,fPt(t.fPt)
+  ,fdQdl(t.fdQdl)
+{
+  //
+  // AliTRDmcmTracklet copy constructor
+  //
+
+  for (Int_t time = 0; time < kNtimeBins; time++) {
+    for (Int_t icl = 0; icl < kNclsPads; icl++) {
+      ((AliTRDmcmTracklet &) t).fADC[time][icl] = 0;
+    }
+    for (Int_t it = 0; it < kNdict; it++) {
+      ((AliTRDmcmTracklet &) t).fTrack[time][it] = -1;
+    }
+    ((AliTRDmcmTracklet &) t).fTime[time]   = 0;
+    ((AliTRDmcmTracklet &) t).fCol[time]    = 0;
+  }
+
+  if (fGeo) {
+    delete fGeo;
+  }
+  fGeo = new AliTRDgeometry();
 
 }
 
 //_____________________________________________________________________________
-AliTRDmcmTracklet::AliTRDmcmTracklet(Int_t det, Int_t row, Int_t n
+AliTRDmcmTracklet::~AliTRDmcmTracklet(
 {
+  //
+  // AliTRDmcmTracklet destructor
+  //
+
+  if (fGPos != 0) delete fGPos;
+  if (fGAmp != 0) delete fGAmp;
+
+  if (fGeo) {
+    delete fGeo;
+  }
 
+}
+
+//_____________________________________________________________________________
+AliTRDmcmTracklet &AliTRDmcmTracklet::operator=(const AliTRDmcmTracklet &t)
+{
   //
-  // AliTRDmcmTracklet default constructor
+  // Assignment operator
+  //
+
+  if (this != &t) ((AliTRDmcmTracklet &) t).Copy(*this); 
+  return *this;
+
+}
+
+//_____________________________________________________________________________
+void AliTRDmcmTracklet::Copy(TObject &t) const
+{
+  //
+  // Copy function
   //
 
-  fDetector = det;
-  fRow      = row;
+  ((AliTRDmcmTracklet &) t).fDetector    = fDetector;
+  ((AliTRDmcmTracklet &) t).fRow         = fRow;
+  ((AliTRDmcmTracklet &) t).fTrackLabel  = fTrackLabel;
+  ((AliTRDmcmTracklet &) t).fNclusters   = fNclusters;
+  ((AliTRDmcmTracklet &) t).fN           = fN;
+  ((AliTRDmcmTracklet &) t).fGPos        = NULL;
+  ((AliTRDmcmTracklet &) t).fGAmp        = NULL;
+  ((AliTRDmcmTracklet &) t).fTime0       = fTime0;
+  ((AliTRDmcmTracklet &) t).fRowz        = fRowz;
+  ((AliTRDmcmTracklet &) t).fSlope       = fSlope;
+  ((AliTRDmcmTracklet &) t).fOffset      = fOffset;
+  ((AliTRDmcmTracklet &) t).fPt          = fPt;
+  ((AliTRDmcmTracklet &) t).fdQdl        = fdQdl;
+
+  for (Int_t time = 0; time < kNtimeBins; time++) {
+    for (Int_t icl = 0; icl < kNclsPads; icl++) {
+      ((AliTRDmcmTracklet &) t).fADC[time][icl] = 0;
+    }
+    for (Int_t it = 0; it < kNdict; it++) {
+      ((AliTRDmcmTracklet &) t).fTrack[time][it] = -1;
+    }
+    ((AliTRDmcmTracklet &) t).fTime[time]   = 0;
+    ((AliTRDmcmTracklet &) t).fCol[time]    = 0;
+  }
+
+}
+
+//_____________________________________________________________________________
+void AliTRDmcmTracklet::Reset() 
+{
+  //
+  // Reset the tracklet information
+  //
+
+  fDetector = -1;
+  fRow      = -1;
 
   for (Int_t time = 0; time < kNtimeBins; time++) {
     for (Int_t icl = 0; icl < kNclsPads; icl++) {
@@ -86,14 +235,12 @@ AliTRDmcmTracklet::AliTRDmcmTracklet(Int_t det, Int_t row, Int_t n)
     fCol[time]    = 0;
   }
 
-  fNclusters = 0;
-
-  fN = n;
-
+  fNclusters  =  0;
+  fN          =  0;
   fTrackLabel = -1;
 
-  fGPos = new TGraph(0);
-  fGAmp = new TGraph(0);
+  fGPos->Set(0);
+  fGAmp->Set(0);
 
   fSlope  = 0.0;
   fOffset = 0.0;
@@ -105,39 +252,48 @@ AliTRDmcmTracklet::AliTRDmcmTracklet(Int_t det, Int_t row, Int_t n)
 }
 
 //_____________________________________________________________________________
-AliTRDmcmTracklet::~AliTRDmcmTracklet(
+void AliTRDmcmTracklet::AddCluster(Int_t icol, Int_t itb, Float_t *adc, Int_t *track
 {
-
   //
-  // AliTRDmcmTracklet destructor
+  // Add a cluster to the tracklet
   //
+  if (fNclusters >= kNtimeBins) return;
+
+  for (Int_t icl = 0; icl < kNclsPads; icl++) {
+    fADC[fNclusters][icl] = adc[icl]; 
+  }
+
+  fTrack[fNclusters][0] = track[0];
+  fTrack[fNclusters][1] = track[1];
+  fTrack[fNclusters][2] = track[2];
+  fTime[fNclusters] = itb;
+  fCol[fNclusters] = icol;
+
+  fNclusters++;
 
 }
 
 //_____________________________________________________________________________
 void AliTRDmcmTracklet::MakeTrackletGraph(AliTRDgeometry *geo, Float_t field) 
 {
-
   //
   // Tracklet graph of positions (global coordinates, rotated [cm])
   //
   
   if (!geo) {
-    Error("MakeTrackletGraph","No geometry.");
+    AliError("No geometry.");
     return;
   }
   
-  AliTRDCommonParam* commonParam = AliTRDCommonParam::Instance();
-  if (!commonParam)
-  {
-    Error("MakeTrackletGraph","No common params.");
+  if (!AliTRDCommonParam::Instance()) {
+    AliError("No common parameters.");
     return;
   }
 
   AliTRDcalibDB* calibration = AliTRDcalibDB::Instance();
-  if (!calibration)
-  {
-    Error("MakeTrackletGraph","No instance of AliTRDcalibDB.");
+  if (!calibration) {
+    AliError("No instance of AliTRDcalibDB.");
     return;
   }
 
@@ -146,15 +302,15 @@ void AliTRDmcmTracklet::MakeTrackletGraph(AliTRDgeometry *geo, Float_t field)
   iplan = geo->GetPlane(fDetector);
   icham = geo->GetChamber(fDetector);
 
-  AliTRDpadPlane *padPlane = commonParam->GetPadPlane(iplan,icham);
+  AliTRDpadPlane *padPlane = fGeo->GetPadPlane(iplan,icham);
 
-  Float_t SamplFreq = calibration->GetSamplingFrequency();
+  Float_t samplFreq = AliTRDCommonParam::Instance()->GetSamplingFrequency();
 
   Int_t time, col;
   Float_t amp[3];
-  Float_t Xpos, Ypos, Xzero, ColSize, TimeBinSize;
-  Float_t vDrift, OmegaTau, LorentzAngle, ThetaSlope;
-  Float_t TiltingAngle;
+  Float_t xpos, ypos, xzero, colSize, timeBinSize;
+  Float_t vDrift, omegaTau, lorentzAngle, thetaSlope;
+  Float_t tiltingAngle;
   Int_t npg = 0;
 
   for (Int_t icl = 0; icl < fNclusters; icl++) {
@@ -169,32 +325,32 @@ void AliTRDmcmTracklet::MakeTrackletGraph(AliTRDgeometry *geo, Float_t field)
 
     if (amp[0] < 0.0 || amp[1] < 0.0 || amp[2] < 0.0) continue;
 
-    Ypos = GetClusY(amp,iplan);
+    ypos = GetClusY(amp,iplan);
 
-    ColSize = padPlane->GetColSize(col);
+    colSize = padPlane->GetColSize(col);
     vDrift = calibration->GetVdrift(fDetector,col,fRow);
-    TimeBinSize = vDrift/SamplFreq;
+    timeBinSize = vDrift/samplFreq;
     
     // From v4-03-Release to HEAD28Mar06 the sign has changed from "-" to "+" 
     // due to a change in the digitizer
-    OmegaTau = +TMath::Sign(1.0,(Double_t)field)*GetOmegaTau(vDrift,TMath::Abs(field));
-    LorentzAngle = TMath::ATan(OmegaTau)*180.0/TMath::Pi();
+    omegaTau     = TMath::Sign(1.0,(Double_t)field)*GetOmegaTau(vDrift,TMath::Abs(field));
+    lorentzAngle = TMath::ATan(omegaTau)*180.0/TMath::Pi();
     
-    Xpos = (time+0.5) * TimeBinSize;
-    Xpos = geo->GetTime0(iplan) - Xpos;
+    xpos = (time+0.5) * timeBinSize;
+    xpos = geo->GetTime0(iplan) - xpos;
 
-    Ypos = padPlane->GetColPos(col) - (Ypos + 0.5) * ColSize;
+    ypos = padPlane->GetColPos(col) - (ypos + 0.5) * colSize;
 
     // ExB correction
-    Xzero = geo->GetTime0(iplan);
-    Ypos = Ypos + (Xpos-Xzero) * OmegaTau;
+    xzero = geo->GetTime0(iplan);
+    ypos = ypos + (xpos-xzero) * omegaTau;
 
     // tilted pads correction
-    ThetaSlope = - padPlane->GetRowPos(fRow)/geo->GetTime0(iplan);
-    TiltingAngle = padPlane->GetTiltingAngle()/180.0*TMath::Pi();
-    Ypos = Ypos - (Xpos-Xzero) * ThetaSlope * TMath::Sin(TiltingAngle);
+    thetaSlope = - padPlane->GetRowPos(fRow)/geo->GetTime0(iplan);
+    tiltingAngle = padPlane->GetTiltingAngle()/180.0*TMath::Pi();
+    ypos = ypos - (xpos-xzero) * thetaSlope * TMath::Sin(tiltingAngle);
 
-    fGPos->SetPoint(npg,(Double_t)Xpos,(Double_t)Ypos);
+    fGPos->SetPoint(npg,(Double_t)xpos,(Double_t)ypos);
     npg++;
 
   }
@@ -202,11 +358,15 @@ void AliTRDmcmTracklet::MakeTrackletGraph(AliTRDgeometry *geo, Float_t field)
   fGPos->Set(npg);
   
   fTime0 = geo->GetTime0(iplan) - AliTRDgeometry::CdrHght() - 0.5*AliTRDgeometry::CamHght();
-  fRowz = 0.5*(padPlane->GetRowPos(fRow) + padPlane->GetRowPos(fRow+1));
-
-  Double_t xMin = 0, xMax = 0, x, y;
-  fGPos->GetPoint(0    ,x,y); xMax = x + 0.1;
-  fGPos->GetPoint(npg-1,x,y); xMin = x - 0.1;
+  fRowz = padPlane->GetRowPos(fRow) - padPlane->GetRowSize(fRow)/2.0;
+
+  Double_t xMin = 0;
+  Double_t xMax = 0;
+  Double_t x, y;
+  fGPos->GetPoint(0    ,x,y); 
+  xMax = x + 0.1;
+  fGPos->GetPoint(npg-1,x,y); 
+  xMin = x - 0.1;
   
   TF1 *line = new TF1("line","[0]+x*[1]",xMin,xMax);
   fGPos->Fit(line,"WRQ0");
@@ -216,14 +376,14 @@ void AliTRDmcmTracklet::MakeTrackletGraph(AliTRDgeometry *geo, Float_t field)
 
   line->Delete();
   
-  Float_t fX = fTime0;
-  Float_t fY = fOffset;
+  Float_t fx = fTime0;
+  Float_t fy = fOffset;
   
-  Float_t infSlope = TMath::ATan(fY/fX)/TMath::Pi()*180.0;    
-  Float_t alpha = fSlope - infSlope;
-  Float_t R = TMath::Sqrt(fX*fX + fY*fY)/(2.0*TMath::Sin(alpha/180.0*TMath::Pi()));
+  Float_t infSlope = TMath::ATan(fy/fx)/TMath::Pi()*180.0;    
+  Float_t alpha    = fSlope - infSlope;
+  Float_t r        = TMath::Sqrt(fx*fx + fy*fy)/(2.0*TMath::Sin(alpha/180.0*TMath::Pi()));
 
-  fPt = 0.3 * field * 0.01 * R;
+  fPt = 0.3 * field * 0.01 * r;
   
   return;
 
@@ -236,16 +396,10 @@ void AliTRDmcmTracklet::MakeClusAmpGraph()
   // Tracklet graph of cluster charges
   //
 
-  AliTRDcalibDB* calibration = AliTRDcalibDB::Instance();
-  if (!calibration)
-  {
-    Error("MakeClusAmpGraph","No instance of AliTRDcalibDB.");
-    return;
-  }
-
-  Int_t time;
+  Int_t   time;
   Float_t amp[3];
-  Int_t npg = 0;
+  Int_t   npg = 0;
+
   fdQdl = 0.0;
   for (Int_t icl = 0; icl < fNclusters; icl++) {
 
@@ -271,62 +425,62 @@ void AliTRDmcmTracklet::MakeClusAmpGraph()
 }
 
 //_____________________________________________________________________________
-Float_t AliTRDmcmTracklet::GetClusY(Float_t *adc, Int_t pla) 
+Float_t AliTRDmcmTracklet::GetClusY(Float_t *adc, Int_t pla) const
 {
   //
   // Cluster position in the phi direction in pad units (relative to the pad border)
   //
 
-  Float_t Ypos = 0.0;
+  Float_t ypos = 0.0;
 
-  Float_t A0 = adc[0];
-  Float_t A1 = adc[1];
-  Float_t A2 = adc[2];
+  Float_t a0 = adc[0];
+  Float_t a1 = adc[1];
+  Float_t a2 = adc[2];
 
-  Float_t T1, T2, W1 ,W2;
+  Float_t t1, t2, w1 ,w2;
 
-  Float_t W = 1.0;  // pad units
+  Float_t w = 1.0;  // pad units
 
-  Float_t Sigma = 0.0;
+  Float_t sigma = 0.0;
 
   switch(pla) {
   case 0:
-    Sigma = 0.515; break;
+    sigma = 0.515; break;
   case 1:
-    Sigma = 0.501; break;
+    sigma = 0.501; break;
   case 2:
-    Sigma = 0.491; break;
+    sigma = 0.491; break;
   case 3:
-    Sigma = 0.481; break;
+    sigma = 0.481; break;
   case 4:
-    Sigma = 0.471; break;
+    sigma = 0.471; break;
   case 5:
-    Sigma = 0.463; break;
+    sigma = 0.463; break;
   default:
-    Error("GetClusY","Wrong plane number.");
+    AliError("Wrong plane number.");
     return 0.0;
   }
 
-  Sigma *= W;
+  sigma *= w;
 
-  T1 = 0.0;
-  W1 = 0.0;
-  if( A0 > 0 ) {
-    W1 = A0*A0;
-    //W1 = A0;
-    T1 = W1*((Sigma*Sigma)/W*TMath::Log(A1/A0)-0.5*W);
+  t1 = 0.0;
+  w1 = 0.0;
+  if( a0 > 0 ) {
+    w1 = a0*a0;
+    //w1 = a0;
+    t1 = w1*((sigma*sigma)/w*TMath::Log(a1/a0)-0.5*w);
   }
-  T2 = 0.0;
-  W2 = 0.0;
-  if( A2 > 0 ) {
-    W2 = A2*A2;
-    //W2 = A2;
-    T2 = W2*((Sigma*Sigma)/W*TMath::Log(A2/A1)+0.5*W);
+  t2 = 0.0;
+  w2 = 0.0;
+  if( a2 > 0 ) {
+    w2 = a2*a2;
+    //w2 = a2;
+    t2 = w2*((sigma*sigma)/w*TMath::Log(a2/a1)+0.5*w);
   }
 
-  Ypos = W*(T1+T2)/(W1+W2);  // range: -0.5*W ... +0.5*W
+  ypos = w*(t1+t2)/(w1+w2);  // range: -0.5*w ... +0.5*w
 
-  return Ypos;
+  return ypos;
 
 }
 
@@ -368,7 +522,7 @@ void AliTRDmcmTracklet::CookLabel(Float_t frac)
        trackCount[nTracks]++;
        nTracks++;
        if (nTracks == kMaxTracks) {
-         Warning("CookLabel","Too many tracks for this tracklet.");
+         AliWarning("Too many tracks for this tracklet.");
          nTracks--;
          break;
        }
@@ -388,7 +542,7 @@ void AliTRDmcmTracklet::CookLabel(Float_t frac)
 }
 
 //_____________________________________________________________________________
-Float_t AliTRDmcmTracklet::GetOmegaTau(Float_t vdrift, Float_t field)
+Float_t AliTRDmcmTracklet::GetOmegaTau(Float_t vdrift, Float_t field) const
 {
   //
   // Returns omega*tau (tan(Lorentz-angle)) for a given drift velocity <vd> 
@@ -411,9 +565,9 @@ Float_t AliTRDmcmTracklet::GetOmegaTau(Float_t vdrift, Float_t field)
   ib       = TMath::Min(kNb,ib);
 
   Float_t alphaL = p0[ib] 
-      + p1[ib] * vdrift
-      + p2[ib] * vdrift*vdrift
-      + p3[ib] * vdrift*vdrift*vdrift;
+                 + p1[ib] * vdrift
+                 + p2[ib] * vdrift*vdrift
+                 + p3[ib] * vdrift*vdrift*vdrift;
 
   return TMath::Tan(alphaL);