]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TPC/AliTPC.cxx
Compatibility with HP
[u/mrichter/AliRoot.git] / TPC / AliTPC.cxx
index 67f385972d87dc4fec7ed7d6623964b00f8bb84a..9a1e1b249ba8744b63453336d900c176906f3ec2 100644 (file)
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
 
-/*
-$Log$
-Revision 1.17.2.2  2000/04/10 08:15:12  kowal2
-
-New, experimental data structure from M. Ivanov
-New tracking algorithm
-Different pad geometry for different sectors
-Digitization rewritten
-
-Revision 1.17.2.1  2000/04/10 07:56:53  kowal2
-Not used anymore - removed
-
-Revision 1.17  2000/01/19 17:17:30  fca
-Introducing a list of lists of hits -- more hits allowed for detector now
-
-Revision 1.16  1999/11/05 09:29:23  fca
-Accept only signals > 0
-
-Revision 1.15  1999/10/08 06:26:53  fca
-Removed ClustersIndex - not used anymore
-
-Revision 1.14  1999/09/29 09:24:33  fca
-Introduction of the Copyright and cvs Log
-
-*/
+/* $Id$ */
 
 ///////////////////////////////////////////////////////////////////////////////
 //                                                                           //
@@ -55,38 +31,80 @@ Introduction of the Copyright and cvs Log
 //                                                                          //
 ///////////////////////////////////////////////////////////////////////////////
 
+//
+
+#include <Riostream.h>
+#include <stdlib.h>
+
+#include <TFile.h>  
+#include <TGeometry.h>
+#include <TInterpreter.h>
 #include <TMath.h>
-#include <TRandom.h>
-#include <TVector.h>
 #include <TMatrix.h>
-#include <TGeometry.h>
 #include <TNode.h>
-#include <TTUBS.h>
 #include <TObjectTable.h>
-#include "TParticle.h"
-#include "AliTPC.h"
-#include "AliRun.h"
-#include <iostream.h>
-#include <fstream.h>
-#include "AliMC.h"
-
+#include <TParticle.h>
+#include <TROOT.h>
+#include <TRandom.h>
+#include <TSystem.h>     
+#include <TTUBS.h>
+#include <TTree.h>
+#include <TVector.h>
+#include <TVirtualMC.h>
 
-#include "AliTPCParam.h"
-#include "AliTPCPRF2D.h"
-#include "AliTPCRF1D.h"
+#include "AliArrayBranch.h"
+#include "AliClusters.h"
+#include "AliComplexCluster.h"
 #include "AliDigits.h"
+#include "AliMagF.h"
+#include "AliPoints.h"
+#include "AliRun.h"
+#include "AliRunLoader.h"
 #include "AliSimDigits.h"
-
-#include "AliTPCDigitsArray.h"
-#include "AliCluster.h"
-#include "AliClusters.h"
-#include "AliTPCClustersRow.h"
+#include "AliTPC.h"
+#include "AliTPC.h"
 #include "AliTPCClustersArray.h"
-
+#include "AliTPCClustersRow.h"
+#include "AliTPCDigitsArray.h"
+#include "AliTPCLoader.h"
+#include "AliTPCPRF2D.h"
+#include "AliTPCParamSR.h"
+#include "AliTPCRF1D.h"
+#include "AliTPCTrackHits.h"
+#include "AliTPCTrackHitsV2.h"
+#include "AliTPCcluster.h"
+#include "AliTrackReference.h"
 
 
 ClassImp(AliTPC) 
 
+//_____________________________________________________________________________
+// helper class for fast matrix and vector manipulation - no range checking
+// origin - Marian Ivanov
+
+class AliTPCFastMatrix : public TMatrix {
+public :
+  AliTPCFastMatrix(Int_t row_lwb, Int_t row_upb, Int_t col_lwb, Int_t col_upb);
+  inline Float_t & UncheckedAt(Int_t rown, Int_t coln) const  {return  (fIndex[coln])[rown];} //fast acces   
+  inline Float_t   UncheckedAtFast(Int_t rown, Int_t coln) const  {return  (fIndex[coln])[rown];} //fast acces   
+};
+
+AliTPCFastMatrix::AliTPCFastMatrix(Int_t row_lwb, Int_t row_upb, Int_t col_lwb, Int_t col_upb):
+  TMatrix(row_lwb, row_upb,col_lwb,col_upb)
+   {
+   };
+//_____________________________________________________________________________
+class AliTPCFastVector : public TVector {
+public :
+  AliTPCFastVector(Int_t size);
+  virtual ~AliTPCFastVector(){;}
+  inline Float_t & UncheckedAt(Int_t index) const  {return  fElements[index];} //fast acces  
+  
+};
+
+AliTPCFastVector::AliTPCFastVector(Int_t size):TVector(size){
+};
+
 //_____________________________________________________________________________
 AliTPC::AliTPC()
 {
@@ -94,17 +112,19 @@ AliTPC::AliTPC()
   // Default constructor
   //
   fIshunt   = 0;
-  fClusters = 0;
   fHits     = 0;
   fDigits   = 0;
-  fTracks   = 0;
   fNsectors = 0;
-  fNtracks  = 0;
-  fNclusters= 0;
-  //MI changes
   fDigitsArray = 0;
   fClustersArray = 0;
-  fTPCParam = 0;
+  fDefaults = 0;
+  fTrackHits = 0; 
+  fTrackHitsOld = 0;   
+  fHitType = 2; //default CONTAINERS - based on ROOT structure 
+  fTPCParam = 0;    
+  fNoiseTable = 0;
+  fActiveSectors =0;
+
 }
  
 //_____________________________________________________________________________
@@ -118,23 +138,47 @@ AliTPC::AliTPC(const char *name, const char *title)
   //
   // Initialise arrays of hits and digits 
   fHits     = new TClonesArray("AliTPChit",  176);
-  //MI change  
+  gAlice->AddHitList(fHits); 
   fDigitsArray = 0;
   fClustersArray= 0;
-  fTPCParam = 0;
+  fDefaults = 0;
+  //
+  fTrackHits = new AliTPCTrackHitsV2;  
+  fTrackHits->SetHitPrecision(0.002);
+  fTrackHits->SetStepPrecision(0.003);  
+  fTrackHits->SetMaxDistance(100);
+
+  fTrackHitsOld = new AliTPCTrackHits;  //MI - 13.09.2000
+  fTrackHitsOld->SetHitPrecision(0.002);
+  fTrackHitsOld->SetStepPrecision(0.003);  
+  fTrackHitsOld->SetMaxDistance(100); 
+
+  fNoiseTable =0;
+
+  fHitType = 2;
+  fActiveSectors = 0;
   //
   // Initialise counters
-  fClusters = 0;
-  fTracks   = 0;
   fNsectors = 0;
-  fNtracks  = 0;
-  fNclusters= 0;
 
   //
   fIshunt     =  0;
   //
   // Initialise color attributes
   SetMarkerColor(kYellow);
+
+  //
+  //  Set TPC parameters
+  //
+
+
+  if (!strcmp(title,"Default")) {       
+    fTPCParam = new AliTPCParamSR;
+  } else {
+    cerr<<"AliTPC warning: in Config.C you must set non-default parameters\n";
+    fTPCParam=0;
+  }
+
 }
 
 //_____________________________________________________________________________
@@ -143,68 +187,31 @@ AliTPC::~AliTPC()
   //
   // TPC destructor
   //
+
   fIshunt   = 0;
   delete fHits;
   delete fDigits;
-  delete fClusters;
-  delete fTracks;
-  if (fDigitsArray!=0) delete fDigitsArray;
-  if (fClustersArray!=0) delete fClustersArray;
+  delete fTPCParam;
+  delete fTrackHits; //MI 15.09.2000
+  delete fTrackHitsOld; //MI 10.12.2001
+  if (fNoiseTable) delete [] fNoiseTable;
 
-  if (fTPCParam) delete fTPCParam;
 }
 
-//_____________________________________________________________________________
-void AliTPC::AddCluster(Float_t *hits, Int_t *tracks)
-{
-  //
-  // Add a simulated cluster to the list
-  //
-  if(!fClusters) fClusters=new TClonesArray("AliTPCcluster",10000);
-  TClonesArray &lclusters = *fClusters;
-  new(lclusters[fNclusters++]) AliTPCcluster(hits,tracks);
-}
-//_____________________________________________________________________________
-void AliTPC::AddCluster(const AliTPCcluster &c)
-{
-  //
-  // Add a simulated cluster copy to the list
-  //
-  if(!fClusters) fClusters=new TClonesArray("AliTPCcluster",900000);
-  TClonesArray &lclusters = *fClusters;
-  new(lclusters[fNclusters++]) AliTPCcluster(c);
-}
 //_____________________________________________________________________________
 void AliTPC::AddHit(Int_t track, Int_t *vol, Float_t *hits)
 {
   //
   // Add a hit to the list
   //
-  TClonesArray &lhits = *fHits;
-  new(lhits[fNhits++]) AliTPChit(fIshunt,track,vol,hits);
-}
-//_____________________________________________________________________________
-void AliTPC::AddTrack(Float_t *hits)
-{
-  //
-  // Add a track to the list of tracks
-  //
-  TClonesArray &ltracks = *fTracks;
-  new(ltracks[fNtracks++]) AliTPCtrack(hits);
-}
-
-//_____________________________________________________________________________
-void AliTPC::AddTrack(const AliTPCtrack& t)
-{
-  //
-  // Add a track copy to the list of tracks
-  //
-  if(!fTracks) fTracks=new TClonesArray("AliTPCtrack",10000);
-  TClonesArray &ltracks = *fTracks;
-  new(ltracks[fNtracks++]) AliTPCtrack(t);
+  //  TClonesArray &lhits = *fHits;
+  //  new(lhits[fNhits++]) AliTPChit(fIshunt,track,vol,hits);
+  if (fHitType&1){
+    TClonesArray &lhits = *fHits;
+    new(lhits[fNhits++]) AliTPChit(fIshunt,track,vol,hits);
+  }
+  if (fHitType>1)
+   AddHit2(track,vol,hits);
 }
 
 //_____________________________________________________________________________
@@ -214,7 +221,7 @@ void AliTPC::BuildGeometry()
   //
   // Build TPC ROOT TNode geometry for the event display
   //
-  TNode *Node, *Top;
+  TNode *nNode, *nTop;
   TTUBS *tubs;
   Int_t i;
   const int kColorTPC=19;
@@ -223,23 +230,23 @@ void AliTPC::BuildGeometry()
   const Double_t kRaddeg=180./TMath::Pi();
 
 
-  Float_t InnerOpenAngle = fTPCParam->GetInnerAngle();
-  Float_t OuterOpenAngle = fTPCParam->GetOuterAngle();
+  Float_t innerOpenAngle = fTPCParam->GetInnerAngle();
+  Float_t outerOpenAngle = fTPCParam->GetOuterAngle();
 
-  Float_t InnerAngleShift = fTPCParam->GetInnerAngleShift();
-  Float_t OuterAngleShift = fTPCParam->GetOuterAngleShift();
+  Float_t innerAngleShift = fTPCParam->GetInnerAngleShift();
+  Float_t outerAngleShift = fTPCParam->GetOuterAngleShift();
 
   Int_t nLo = fTPCParam->GetNInnerSector()/2;
   Int_t nHi = fTPCParam->GetNOuterSector()/2;  
 
-  const Double_t loAng = (Double_t)TMath::Nint(InnerOpenAngle*kRaddeg);
-  const Double_t hiAng = (Double_t)TMath::Nint(OuterOpenAngle*kRaddeg);
-  const Double_t loAngSh = (Double_t)TMath::Nint(InnerAngleShift*kRaddeg);
-  const Double_t hiAngSh = (Double_t)TMath::Nint(OuterAngleShift*kRaddeg);  
+  const Double_t kloAng = (Double_t)TMath::Nint(innerOpenAngle*kRaddeg);
+  const Double_t khiAng = (Double_t)TMath::Nint(outerOpenAngle*kRaddeg);
+  const Double_t kloAngSh = (Double_t)TMath::Nint(innerAngleShift*kRaddeg);
+  const Double_t khiAngSh = (Double_t)TMath::Nint(outerAngleShift*kRaddeg);  
 
 
-  const Double_t loCorr = 1/TMath::Cos(0.5*loAng*kDegrad);
-  const Double_t hiCorr = 1/TMath::Cos(0.5*hiAng*kDegrad);
+  const Double_t kloCorr = 1/TMath::Cos(0.5*kloAng*kDegrad);
+  const Double_t khiCorr = 1/TMath::Cos(0.5*khiAng*kDegrad);
 
   Double_t rl,ru;
   
@@ -248,7 +255,7 @@ void AliTPC::BuildGeometry()
   // Get ALICE top node
   //
 
-  Top=gAlice->GetGeometry()->GetNode("alice");
+  nTop=gAlice->GetGeometry()->GetNode("alice");
 
   //  inner sectors
 
@@ -262,13 +269,13 @@ void AliTPC::BuildGeometry()
     sprintf(title,"TPC low sector %3d",i);
     title[24]='\0';
     
-    tubs = new TTUBS(name,title,"void",rl*loCorr,ru*loCorr,250.,
-                     loAng*(i-0.5)+loAngSh,loAng*(i+0.5)+loAngSh);
+    tubs = new TTUBS(name,title,"void",rl*kloCorr,ru*kloCorr,250.,
+                     kloAng*(i-0.5)+kloAngSh,kloAng*(i+0.5)+kloAngSh);
     tubs->SetNumberOfDivisions(1);
-    Top->cd();
-    Node = new TNode(name,title,name,0,0,0,"");
-    Node->SetLineColor(kColorTPC);
-    fNodes->Add(Node);
+    nTop->cd();
+    nNode = new TNode(name,title,name,0,0,0,"");
+    nNode->SetLineColor(kColorTPC);
+    fNodes->Add(nNode);
   }
 
   // Outer sectors
@@ -281,19 +288,16 @@ void AliTPC::BuildGeometry()
     name[4]='\0';
     sprintf(title,"TPC upper sector %d",i);
     title[24]='\0';
-    tubs = new TTUBS(name,title,"void",rl*hiCorr,ru*hiCorr,250,
-                     hiAng*(i-0.5)+hiAngSh,hiAng*(i+0.5)+hiAngSh);
+    tubs = new TTUBS(name,title,"void",rl*khiCorr,ru*khiCorr,250,
+                     khiAng*(i-0.5)+khiAngSh,khiAng*(i+0.5)+khiAngSh);
     tubs->SetNumberOfDivisions(1);
-    Top->cd();
-    Node = new TNode(name,title,name,0,0,0,"");
-    Node->SetLineColor(kColorTPC);
-    fNodes->Add(Node);
+    nTop->cd();
+    nNode = new TNode(name,title,name,0,0,0,"");
+    nNode->SetLineColor(kColorTPC);
+    fNodes->Add(nNode);
   }
 
-
-}  
-  
-  
+}    
 
 //_____________________________________________________________________________
 Int_t AliTPC::DistancetoPrimitive(Int_t , Int_t )
@@ -305,385 +309,64 @@ Int_t AliTPC::DistancetoPrimitive(Int_t , Int_t )
   return 9999;
 }
 
-//_____________________________________________________________________________
-static Double_t SigmaY2(Double_t r, Double_t tgl, Double_t pt)
-{
-  //
-  // Parametrised error of the cluster reconstruction (pad direction)   
-  //
-  pt=TMath::Abs(pt)*1000.;
-  Double_t x=r/pt;
-  tgl=TMath::Abs(tgl);
-  Double_t s=a_rphi - b_rphi*r*tgl + c_rphi*x*x + d_rphi*x;
-  if (s<0.4e-3) s=0.4e-3;
-  s*=1.3; //Iouri Belikov
-  return s;
-}
-
-//_____________________________________________________________________________
-static Double_t SigmaZ2(Double_t r, Double_t tgl) 
-{
-  //
-  // Parametrised error of the cluster reconstruction (drift direction)
-  //
-  tgl=TMath::Abs(tgl);
-  Double_t s=a_z - b_z*r*tgl + c_z*tgl*tgl;
-  if (s<0.4e-3) s=0.4e-3;
-  s*=1.3; //Iouri Belikov
-  return s;
-}
-
-//_____________________________________________________________________________
-inline Double_t f1(Double_t x1,Double_t y1,
-                   Double_t x2,Double_t y2,
-                   Double_t x3,Double_t y3) 
-{
-  //-----------------------------------------------------------------
-  // Initial approximation of the track curvature
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  Double_t d=(x2-x1)*(y3-y2)-(x3-x2)*(y2-y1);
-  Double_t a=0.5*((y3-y2)*(y2*y2-y1*y1+x2*x2-x1*x1)-
-                  (y2-y1)*(y3*y3-y2*y2+x3*x3-x2*x2));
-  Double_t b=0.5*((x2-x1)*(y3*y3-y2*y2+x3*x3-x2*x2)-
-                  (x3-x2)*(y2*y2-y1*y1+x2*x2-x1*x1));
-
-  Double_t xr=TMath::Abs(d/(d*x1-a)), yr=d/(d*y1-b);
-
-  return -xr*yr/sqrt(xr*xr+yr*yr); 
-}
-
-
-//_____________________________________________________________________________
-inline Double_t f2(Double_t x1,Double_t y1,
-                   Double_t x2,Double_t y2,
-                   Double_t x3,Double_t y3) 
-{
-  //-----------------------------------------------------------------
-  // Initial approximation of the track curvature times center of curvature
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  Double_t d=(x2-x1)*(y3-y2)-(x3-x2)*(y2-y1);
-  Double_t a=0.5*((y3-y2)*(y2*y2-y1*y1+x2*x2-x1*x1)-
-                  (y2-y1)*(y3*y3-y2*y2+x3*x3-x2*x2));
-  Double_t b=0.5*((x2-x1)*(y3*y3-y2*y2+x3*x3-x2*x2)-
-                  (x3-x2)*(y2*y2-y1*y1+x2*x2-x1*x1));
-
-  Double_t xr=TMath::Abs(d/(d*x1-a)), yr=d/(d*y1-b);
-  
-  return -a/(d*y1-b)*xr/sqrt(xr*xr+yr*yr);
-}
-
-//_____________________________________________________________________________
-inline Double_t f3(Double_t x1,Double_t y1, 
-                   Double_t x2,Double_t y2,
-                   Double_t z1,Double_t z2) 
-{
-  //-----------------------------------------------------------------
-  // Initial approximation of the tangent of the track dip angle
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  return (z1 - z2)/sqrt((x1-x2)*(x1-x2)+(y1-y2)*(y1-y2));
-}
-
-//_____________________________________________________________________________
-static Int_t FindProlongation(AliTPCtrack& t, const AliTPCSector *sec,
-                           Int_t s, Int_t rf=0) 
-{
-  //-----------------------------------------------------------------
-  // This function tries to find a track prolongation.
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  const Int_t ROWS_TO_SKIP=(t<10) ? 10 : Int_t(0.5*sec->GetNRows());
-  const Float_t MAX_CHI2=12.;
-  Int_t try_again=ROWS_TO_SKIP;
-  Double_t alpha=sec->GetAlpha();
-  Int_t ns=Int_t(2*TMath::Pi()/alpha+0.5);
-
-  for (Int_t nr=sec->GetRowNumber(t.GetX())-1; nr>=rf; nr--) {
-    Double_t x=sec->GetX(nr), ymax=sec->GetMaxY(nr);
-    if (!t.PropagateTo(x)) return 0;
-
-    AliTPCcluster *cl=0;
-    Double_t max_chi2=MAX_CHI2;
-    const AliTPCRow& row=sec[s][nr];
-    Double_t sy2=SigmaY2(t.GetX(),t.GetTgl(),t.GetPt());
-    Double_t sz2=SigmaZ2(t.GetX(),t.GetTgl());
-    Double_t road=5.*sqrt(t.GetSigmaY2() + sy2), y=t.GetY(), z=t.GetZ();
-
-    if (road>30) {
-      if (t>4) cerr<<t<<" FindProlongation warning: Too broad road !\n"; 
-      return 0;
-    }
-
-    if (row) {
-      for (Int_t i=row.Find(y-road); i<row; i++) {
-       AliTPCcluster* c=(AliTPCcluster*)(row[i]);
-       if (c->fY > y+road) break;
-       if (c->IsUsed()) continue;
-       if ((c->fZ - z)*(c->fZ - z) > 25.*(t.GetSigmaZ2() + sz2)) continue;
-       Double_t chi2=t.GetPredictedChi2(c);
-       if (chi2 > max_chi2) continue;
-       max_chi2=chi2;
-       cl=c;       
-      }
-    }
-    if (cl) {
-      t.Update(cl,max_chi2);
-      cl->fdEdX=sec->GetPadPitchWidth()*TMath::Sqrt((1+t.GetTgl()*t.GetTgl())/
-               (1-(t.GetC()*x-t.GetEta())*(t.GetC()*x-t.GetEta())));
-      try_again=ROWS_TO_SKIP;
-    } else {
-      if (try_again==0) break;
-      if (y > ymax) {
-         s = (s+1) % ns;
-         if (!t.Rotate(alpha)) return 0;
-      } else if (y <-ymax) {
-         s = (s-1+ns) % ns;
-         if (!t.Rotate(-alpha)) return 0;
-      }
-      try_again--;
-    }
-  }
-
-  return 1;
-
-}
-
-
-//_____________________________________________________________________________
-static void MakeSeeds(TObjArray& seeds,const AliTPCSector *sec, Int_t max_sec,
-Int_t i1, Int_t i2)
-{
-  //-----------------------------------------------------------------
-  // This function creates track seeds.
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  TMatrix C(5,5); TVector x(5);
-  Double_t alpha=sec->GetAlpha(), shift=sec->GetAlphaShift();
-  Double_t cs=cos(alpha), sn=sin(alpha);
-  for (Int_t ns=0; ns<max_sec; ns++) {
-    Int_t nl=sec[(ns-1+max_sec)%max_sec][i2];
-    Int_t nm=sec[ns][i2];
-    Int_t nu=sec[(ns+1)%max_sec][i2];
-    const AliTPCRow& r1=sec[ns][i1];
-    for (Int_t is=0; is < r1; is++) {
-      Double_t x1=sec->GetX(i1), y1=r1[is]->fY, z1=r1[is]->fZ;
-      for (Int_t js=0; js < nl+nm+nu; js++) {
-       const AliTPCcluster *cl;
-       Int_t ks;
-        Double_t x2=sec->GetX(i2), y2, z2, tmp;
-
-       if (js<nl) {
-         ks=(ns-1+max_sec)%max_sec;
-         const AliTPCRow& r2=sec[(ns-1+max_sec)%max_sec][i2];
-         cl=r2[js];
-          y2=cl->fY; z2=cl->fZ;
-          tmp= x2*cs+y2*sn;
-          y2 =-x2*sn+y2*cs; x2=tmp;
-       } else 
-         if (js<nl+nm) {
-           ks=ns;
-           const AliTPCRow& r2=sec[ns][i2];
-           cl=r2[js-nl];
-            y2=cl->fY; z2=cl->fZ;
-         } else {
-           ks=(ns+1)%max_sec;
-           const AliTPCRow& r2=sec[(ns+1)%max_sec][i2];
-           cl=r2[js-nl-nm];
-            y2=cl->fY; z2=cl->fZ;
-            tmp=x2*cs-y2*sn;
-            y2 =x2*sn+y2*cs; x2=tmp;
-         }
-
-        Double_t zz=z1 - z1/x1*(x1-x2); 
-        if (TMath::Abs(zz-z2)>5) continue;
-
-        Double_t d=(x2-x1)*(0.-y2)-(0.-x2)*(y2-y1);
-        if (d==0.) {cerr<<"MakeSeeds warning: Straight seed !\n"; continue;}
-
-        Double_t x3=0., y3=0.;//gRandom->Gaus(0.,TMath::Sqrt(cl->fSigmaY2));
-
-       x(0)=y1;
-       x(1)=z1;
-       x(2)=f1(x1,y1,x2,y2,x3,y3);
-       x(3)=f2(x1,y1,x2,y2,x3,y3);
-       x(4)=f3(x1,y1,x2,y2,z1,z2);
-       
-       if (TMath::Abs(x(2)*x1-x(3)) >= 0.999) continue;
-       
-       if (TMath::Abs(x(4)) > 1.2) continue;
-
-       Double_t a=asin(x(3));
-       Double_t zv=z1 - x(4)/x(2)*(a+asin(x(2)*x1-x(3)));
-       if (TMath::Abs(zv)>10.) continue; 
-
-       TMatrix X(6,6); X=0.; 
-       X(0,0)=r1[is]->fSigmaY2; X(1,1)=r1[is]->fSigmaZ2;
-       X(2,2)=cl->fSigmaY2;     X(3,3)=cl->fSigmaZ2;
-       X(4,4)=cl->fSigmaY2;     X(5,5)=cl->fSigmaZ2;
-       //X(4,4)=3./12.; X(5,5)=3./12.;
-       TMatrix F(5,6); F.UnitMatrix();
-       Double_t sy=sqrt(X(0,0)), sz=sqrt(X(1,1));
-       F(2,0)=(f1(x1,y1+sy,x2,y2,x3,y3)-x(2))/sy;
-       F(2,2)=(f1(x1,y1,x2,y2+sy,x3,y3)-x(2))/sy;
-       F(2,4)=(f1(x1,y1,x2,y2,x3,y3+sy)-x(2))/sy;
-       F(3,0)=(f2(x1,y1+sy,x2,y2,x3,y3)-x(3))/sy;
-       F(3,2)=(f2(x1,y1,x2,y2+sy,x3,y3)-x(3))/sy;
-       F(3,4)=(f2(x1,y1,x2,y2,x3,y3+sy)-x(3))/sy;
-       F(4,0)=(f3(x1,y1+sy,x2,y2,z1,z2)-x(4))/sy;
-       F(4,1)=(f3(x1,y1,x2,y2,z1+sz,z2)-x(4))/sz;
-       F(4,2)=(f3(x1,y1,x2,y2+sy,z1,z2)-x(4))/sy;
-       F(4,3)=(f3(x1,y1,x2,y2,z1,z2+sz)-x(4))/sz;
-       F(4,4)=0;
-       F(3,3)=0;
-       
-       TMatrix t(F,TMatrix::kMult,X);
-       C.Mult(t,TMatrix(TMatrix::kTransposed,F));
-
-       AliTPCtrack *track=new AliTPCtrack(r1[is], x, C, x1, ns*alpha+shift);
-        Int_t rc=FindProlongation(*track,sec,ns,i2);
-        if (rc<0 || *track<(i1-i2)/2) delete track;
-        else seeds.AddLast(track); 
-      }
-    }
-  }
-}
-
-//_____________________________________________________________________________
-AliTPCParam *AliTPCSector::param;
-void AliTPC::Clusters2Tracks()
-{
+void AliTPC::Clusters2Tracks() 
+ {
   //-----------------------------------------------------------------
   // This is a track finder.
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
   //-----------------------------------------------------------------
-  if (!fClusters) return;
-
-  AliTPCParam *p=fTPCParam;
-  AliTPCSector::SetParam(p);
-
-  const Int_t nis=p->GetNInnerSector()/2;
-  AliTPCSSector *ssec=new AliTPCSSector[nis];         
-  Int_t nrow_low=ssec->GetNRows();     
-
-  const Int_t nos=p->GetNOuterSector()/2;
-  AliTPCLSector *lsec=new AliTPCLSector[nos];
-  Int_t nrow_up=lsec->GetNRows();
-
-  Int_t ncl=fClusters->GetEntriesFast();
-  while (ncl--) {
-    AliTPCcluster *c=(AliTPCcluster*)fClusters->UncheckedAt(ncl);
-    Int_t sec=c->fSector, row=c->fPadRow;
-
-    if (sec<nis*2) {
-      ssec[sec%nis][row].InsertCluster(c);
-    } else {
-      sec -= nis*2;
-      lsec[sec%nos][row].InsertCluster(c);
-    }
-  }
-  
-  TObjArray seeds(20000);
-
-  Int_t nrows=nrow_low+nrow_up;
-  Int_t gap=Int_t(0.125*nrows), shift=Int_t(0.5*gap);
-  MakeSeeds(seeds, lsec, nos, nrow_up-1, nrow_up-1-gap);
-  MakeSeeds(seeds, lsec, nos, nrow_up-1-shift, nrow_up-1-shift-gap);
-    
-  seeds.Sort();
-
-  Int_t found=0;
-  Int_t nseed=seeds.GetEntriesFast();
-
-  for (Int_t s=0; s<nseed; s++) {
-    AliTPCtrack *pt=(AliTPCtrack*)seeds.UncheckedAt(s), &t=*pt;
-    Double_t alpha=t.GetAlpha();
-    if (alpha > 2.*TMath::Pi()) alpha -= 2.*TMath::Pi();  
-    if (alpha < 0.            ) alpha += 2.*TMath::Pi();  
-    Int_t ns=Int_t(alpha/lsec->GetAlpha())%nos;
-
-    if (!FindProlongation(t,lsec,ns)) continue;
-
-    alpha=t.GetAlpha() + 0.5*ssec->GetAlpha() - ssec->GetAlphaShift();
-    if (alpha > 2.*TMath::Pi()) alpha -= 2.*TMath::Pi();
-    if (alpha < 0.            ) alpha += 2.*TMath::Pi();
-    ns=Int_t(alpha/ssec->GetAlpha())%nis; //index of the inner sector needed
-
-    alpha=ns*ssec->GetAlpha() - t.GetAlpha();
-    if (!t.Rotate(alpha)) continue;
-    
-    if (!FindProlongation(t,ssec,ns)) continue;
-    
-    if (t >= Int_t(0.4*nrows)) {
-       AddTrack(t);
-       t.UseClusters();
-       cerr<<found++<<'\r';
-    }
-    delete pt; 
-  }  
-
-  delete[] ssec;
-  delete[] lsec;
-
-}
+  Error("Clusters2Tracks",
+  "Dummy function !  Call AliTPCtracker::Clusters2Tracks(...) instead !");
+ }
 
 //_____________________________________________________________________________
 void AliTPC::CreateMaterials()
 {
   //-----------------------------------------------
-  // Create Materials for for TPC
+  // Create Materials for for TPC simulations
   //-----------------------------------------------
 
   //-----------------------------------------------------------------
   // Origin: Marek Kowalski  IFJ, Krakow, Marek.Kowalski@ifj.edu.pl
   //-----------------------------------------------------------------
 
-  Int_t ISXFLD=gAlice->Field()->Integ();
-  Float_t SXMGMX=gAlice->Field()->Max();
+  Int_t iSXFLD=gAlice->Field()->Integ();
+  Float_t sXMGMX=gAlice->Field()->Max();
 
   Float_t amat[5]; // atomic numbers
   Float_t zmat[5]; // z
   Float_t wmat[5]; // proportions
 
   Float_t density;
+  Float_t apure[2];
 
-  //  ********************* Gases *******************
 
-  //--------------------------------------------------------------
+  //***************** Gases *************************
+  
+  //-------------------------------------------------
   // pure gases
-  //--------------------------------------------------------------
+  //-------------------------------------------------
 
-  // Ne
+  // Neon
 
 
-  Float_t a_ne = 20.18;
-  Float_t z_ne = 10.;
-  
+  amat[0]= 20.18;
+  zmat[0]= 10.;  
   density = 0.0009;
+  apure[0]=amat[0];
 
-  AliMaterial(20,"Ne",a_ne,z_ne,density,999.,999.);
+  AliMaterial(20,"Ne",amat[0],zmat[0],density,999.,999.);
 
-  // Ar
+  // Argon
 
-  Float_t a_ar = 39.948;
-  Float_t z_ar = 18.;
+  amat[0]= 39.948;
+  zmat[0]= 18.;  
+  density = 0.001782;  
 
-  density = 0.001782;
-  AliMaterial(21,"Ar",a_ar,z_ar,density,999.,999.);
+  apure[1]=amat[0];
 
-  Float_t a_pure[2];
-  
-  a_pure[0] = a_ne;
-  a_pure[1] = a_ar;
-  
+  AliMaterial(21,"Ar",amat[0],zmat[0],density,999.,999.);
 
   //--------------------------------------------------------------
   // gases - compounds
@@ -691,7 +374,7 @@ void AliTPC::CreateMaterials()
 
   Float_t amol[3];
 
-  //  CO2
+  // CO2
 
   amat[0]=12.011;
   amat[1]=15.9994;
@@ -707,7 +390,7 @@ void AliTPC::CreateMaterials()
   amol[0] = amat[0]*wmat[0]+amat[1]*wmat[1];
 
   AliMixture(10,"CO2",amat,zmat,density,-2,wmat);
-
+  
   // CF4
 
   amat[0]=12.011;
@@ -725,6 +408,7 @@ void AliTPC::CreateMaterials()
 
   AliMixture(11,"CF4",amat,zmat,density,-2,wmat); 
 
+
   // CH4
 
   amat[0]=12.011;
@@ -745,15 +429,14 @@ void AliTPC::CreateMaterials()
   //----------------------------------------------------------------
   // gases - mixtures, ID >= 20 pure gases, <= 10 ID < 20 -compounds
   //----------------------------------------------------------------
-  char namate[21];
+
+  char namate[21]=""; 
   density = 0.;
   Float_t am=0;
   Int_t nc;
-
-  Float_t a,z,rho,absl,X0,buf[1];
+  Float_t rho,absl,X0,buf[1];
   Int_t nbuf;
+  Float_t a,z;
 
   for(nc = 0;nc<fNoComp;nc++)
     {
@@ -767,7 +450,7 @@ void AliTPC::CreateMaterials()
 
       Int_t nnc = (fMixtComp[nc]>=20) ? fMixtComp[nc]%20 : fMixtComp[nc]%10;
  
-      am += fMixtProp[nc]*((fMixtComp[nc]>=20) ? a_pure[nnc] : amol[nnc]); 
+      am += fMixtProp[nc]*((fMixtComp[nc]>=20) ? apure[nnc] : amol[nnc]); 
       density += fMixtProp[nc]*rho;  // density of the mixture
       
     }
@@ -779,41 +462,92 @@ void AliTPC::CreateMaterials()
 
       Int_t nnc = (fMixtComp[nc]>=20) ? fMixtComp[nc]%20 : fMixtComp[nc]%10;
 
-      wmat[nc] = fMixtProp[nc]*((fMixtComp[nc]>=20) ? a_pure[nnc] : amol[nnc])/am;
+      wmat[nc] = fMixtProp[nc]*((fMixtComp[nc]>=20) ? 
+                 apure[nnc] : amol[nnc])/am;
+
+    } 
+
+  // Drift gases 1 - nonsensitive, 2 - sensitive
 
-    }  
-  
   AliMixture(31,"Drift gas 1",amat,zmat,density,fNoComp,wmat);
   AliMixture(32,"Drift gas 2",amat,zmat,density,fNoComp,wmat);
-  AliMixture(33,"Drift gas 3",amat,zmat,density,fNoComp,wmat); 
 
-  AliMedium(2, "Drift gas 1", 31, 0, ISXFLD, SXMGMX, 10., 999.,.1, .001, .001);
-  AliMedium(3, "Drift gas 2", 32, 0, ISXFLD, SXMGMX, 10., 999.,.1, .001, .001);
-  AliMedium(4, "Drift gas 3", 33, 1, ISXFLD, SXMGMX, 10., 999.,.1, .001, .001);
 
-  // Air 
+  // Air
+
+  amat[0] = 14.61;
+  zmat[0] = 7.3;
+  density = 0.001205;
 
-  AliMaterial(24, "Air", 14.61, 7.3, .001205, 30420., 67500.);
+  AliMaterial(24,"Air",amat[0],zmat[0],density,999.,999.); 
 
-  AliMedium(24, "Air", 24, 0, ISXFLD, SXMGMX, 10., .1, .1, .1, .1);
 
   //----------------------------------------------------------------------
   //               solid materials
   //----------------------------------------------------------------------
 
-  // Al
 
-  AliMaterial(30, "Al", 26.98, 13., 2.7, 8.9, 37.2);
+  // Kevlar C14H22O2N2
 
-  AliMedium(0, "Al",30, 0, ISXFLD, SXMGMX, 10., .1, .1, .1,   .1);
+  amat[0] = 12.011;
+  amat[1] = 1.;
+  amat[2] = 15.999;
+  amat[3] = 14.006;
 
-  // Si
+  zmat[0] = 6.;
+  zmat[1] = 1.;
+  zmat[2] = 8.;
+  zmat[3] = 7.;
+
+  wmat[0] = 14.;
+  wmat[1] = 22.;
+  wmat[2] = 2.;
+  wmat[3] = 2.;
+
+  density = 1.45;
+
+  AliMixture(34,"Kevlar",amat,zmat,density,-4,wmat);  
+
+  // NOMEX
+
+  amat[0] = 12.011;
+  amat[1] = 1.;
+  amat[2] = 15.999;
+  amat[3] = 14.006;
+
+  zmat[0] = 6.;
+  zmat[1] = 1.;
+  zmat[2] = 8.;
+  zmat[3] = 7.;
+
+  wmat[0] = 14.;
+  wmat[1] = 22.;
+  wmat[2] = 2.;
+  wmat[3] = 2.;
+
+  density = 0.03;
+
+  
+  AliMixture(35,"NOMEX",amat,zmat,density,-4,wmat);
+
+  // Makrolon C16H18O3
+
+  amat[0] = 12.011;
+  amat[1] = 1.;
+  amat[2] = 15.999;
 
-  AliMaterial(31, "Si", 28.086, 14.,2.33, 9.36, 999.);
+  zmat[0] = 6.;
+  zmat[1] = 1.;
+  zmat[2] = 8.;
 
-  AliMedium(7, "Al",31, 0, ISXFLD, SXMGMX, 10., .1, .1, .1,   .1);
+  wmat[0] = 16.;
+  wmat[1] = 18.;
+  wmat[2] = 3.;
   
+  density = 1.2;
 
+  AliMixture(36,"Makrolon",amat,zmat,density,-3,wmat);
+  
   // Mylar C5H4O2
 
   amat[0]=12.011;
@@ -830,23 +564,9 @@ void AliTPC::CreateMaterials()
 
   density = 1.39;
   
-  AliMixture(32, "Mylar",amat,zmat,density,-3,wmat);
-
-  AliMedium(5, "Mylar",32, 0, ISXFLD, SXMGMX, 10., .1, .1, .001, .01);
-
-
-
-
-  // Carbon (normal)
-
-  AliMaterial(33,"C normal",12.011,6.,2.265,18.8,999.);
-
-  AliMedium(6,"C normal",33,0, ISXFLD, SXMGMX, 10., .1, .1, .001, .01);
+  AliMixture(37, "Mylar",amat,zmat,density,-3,wmat); 
 
-  // G10 for inner and outr field cage
-  // G10 is 60% SiO2 + 40% epoxy, right now I use A and Z for SiO2
-
-  Float_t rhoFactor;
+  // SiO2 - used later for the glass fiber
 
   amat[0]=28.086;
   amat[1]=15.9994;
@@ -857,276 +577,274 @@ void AliTPC::CreateMaterials()
   wmat[0]=1.;
   wmat[1]=2.;
 
-  density = 1.7;
-  
 
-  AliMixture(34,"G10 aux.",amat,zmat,density,-2,wmat);
+  AliMixture(38,"SiO2",amat,zmat,2.2,-2,wmat); //SiO2 - quartz (rho=2.2)
 
+  // Al
 
-  gMC->Gfmate((*fIdmate)[34],namate,a,z,rho,X0,absl,buf,nbuf);
+  amat[0] = 26.98;
+  zmat[0] = 13.;
 
-  Float_t thickX0 = 0.0052; // field cage in X0 units
-  
-  Float_t thick = 2.; // in cm
+  density = 2.7;
 
-  X0=19.4; // G10 
+  AliMaterial(40,"Al",amat[0],zmat[0],density,999.,999.);
 
-  rhoFactor = X0*thickX0/thick;
-  density = rho*rhoFactor;
+  // Si
 
-  AliMaterial(35,"G10-fc",a,z,density,999.,999.);
+  amat[0] = 28.086;
+  zmat[0] = 14.;
 
-  AliMedium(8,"G10-fc",35,0, ISXFLD, SXMGMX, 10., .1, .1, .001, .01);
+  density = 2.33;
 
-  thickX0 = 0.0027; // inner vessel (eta <0.9)
-  thick=0.5;
-  rhoFactor = X0*thickX0/thick;
-  density = rho*rhoFactor;
+  AliMaterial(41,"Si",amat[0],zmat[0],density,999.,999.);
 
-  AliMaterial(36,"G10-iv",a,z,density,999.,999.);  
+  // Cu
 
-  AliMedium(9,"G10-iv",36,0, ISXFLD, SXMGMX, 10., .1, .1, .001, .01);
+  amat[0] = 63.546;
+  zmat[0] = 29.;
 
-  //  Carbon fibre  
-  
-  gMC->Gfmate((*fIdmate)[33],namate,a,z,rho,X0,absl,buf,nbuf);
+  density = 8.96;
 
-  thickX0 = 0.0133; // outer vessel
-  thick=3.0;
-  rhoFactor = X0*thickX0/thick;
-  density = rho*rhoFactor;
+  AliMaterial(42,"Cu",amat[0],zmat[0],density,999.,999.);
 
+  // Tedlar C2H3F
 
-  AliMaterial(37,"C-ov",a,z,density,999.,999.);
+  amat[0] = 12.011;
+  amat[1] = 1.;
+  amat[2] = 18.998;
 
-  AliMedium(10,"C-ov",37,0, ISXFLD, SXMGMX, 10., .1, .1, .001, .01);  
+  zmat[0] = 6.;
+  zmat[1] = 1.;
+  zmat[2] = 9.;
 
-  thickX0=0.015; // inner vessel (cone, eta > 0.9)
-  thick=1.5;
-  rhoFactor = X0*thickX0/thick;
-  density = rho*rhoFactor;
+  wmat[0] = 2.;
+  wmat[1] = 3.; 
+  wmat[2] = 1.;
 
-  AliMaterial(38,"C-ivc",a,z,density,999.,999.);
+  density = 1.71;
 
-  AliMedium(11,"C-ivc",38,0, ISXFLD, SXMGMX, 10., .1, .1, .001, .01);
+  AliMixture(43, "Tedlar",amat,zmat,density,-3,wmat);  
 
-  //
 
-  AliMedium(12,"CO2",10,0, ISXFLD, SXMGMX, 10., 999.,.1, .001, .001);
-    
-}
+  // Plexiglas  C5H8O2
 
-//_____________________________________________________________________________
-struct Bin {
-   UShort_t q;
-   UInt_t mask;
-   Bin();
-};
-Bin::Bin() {q=0; mask=0xFFFFFFFE;}
+  amat[0]=12.011;
+  amat[1]=1.;
+  amat[2]=15.9994;
 
-struct Peak {
-   Int_t k;
-   UInt_t mask;
-};
-inline Bool_t IsMaximum(Int_t k, Int_t max, const Bin *bins) {
-  UShort_t q=bins[k].q;
-  if (q==1023) return kFALSE;
-  if (bins[k-max].q > q) return kFALSE;
-  if (bins[k-1  ].q > q) return kFALSE; 
-  if (bins[k+max].q > q) return kFALSE; 
-  if (bins[k+1  ].q > q) return kFALSE; 
-  if (bins[k-max-1].q > q) return kFALSE;
-  if (bins[k+max-1].q > q) return kFALSE; 
-  if (bins[k+max+1].q > q) return kFALSE; 
-  if (bins[k-max+1].q > q) return kFALSE;
-  return kTRUE; 
-}
-static void FindPeaks(Int_t k, Int_t max, Bin *bins, Peak *peaks, Int_t& n) {
-//if (n>=31) return;
-  if (n<31)
-  if (IsMaximum(k,max,bins)) {
-    peaks[n].k=k; peaks[n].mask=(2<<n);
-    n++;
-  }
-  bins[k].mask=0;
-  if (bins[k-max].mask&1) FindPeaks(k-max,max,bins,peaks,n);
-  if (bins[k-1  ].mask&1) FindPeaks(k-1  ,max,bins,peaks,n);
-  if (bins[k+max].mask&1) FindPeaks(k+max,max,bins,peaks,n);
-  if (bins[k+1  ].mask&1) FindPeaks(k+1  ,max,bins,peaks,n);
-}
+  zmat[0]=6.;
+  zmat[1]=1.;
+  zmat[2]=8.;
 
-static void MarkPeak(Int_t k, Int_t max, Bin *bins, UInt_t m) {
-  UShort_t q=bins[k].q;
+  wmat[0]=5.;
+  wmat[1]=8.;
+  wmat[2]=2.;
 
-  bins[k].mask |= m; 
+  density=1.18;
 
-  if (bins[k-max].q <= q)
-     if ((bins[k-max].mask&m) == 0) MarkPeak(k-max,max,bins,m);
-  if (bins[k-1  ].q <= q)
-     if ((bins[k-1  ].mask&m) == 0) MarkPeak(k-1  ,max,bins,m);
-  if (bins[k+max].q <= q)
-     if ((bins[k+max].mask&m) == 0) MarkPeak(k+max,max,bins,m);
-  if (bins[k+1  ].q <= q)
-     if ((bins[k+1  ].mask&m) == 0) MarkPeak(k+1  ,max,bins,m);
-}
+  AliMixture(44,"Plexiglas",amat,zmat,density,-3,wmat);
 
-static void MakeCluster(Int_t k,Int_t max,Bin *bins,UInt_t m,AliTPCcluster &c){
-  Float_t q=(Float_t)bins[k].q;
-  Int_t i=k/max, j=k-i*max;
-  c.fY += i*q;
-  c.fZ += j*q;
-  c.fSigmaY2 += i*i*q;
-  c.fSigmaZ2 += j*j*q;
-  c.fQ += q;
+  // Epoxy - C14 H20 O3
 
-  bins[k].mask = 0xFFFFFFFE;
   
-  if (bins[k-max].mask == m) MakeCluster(k-max,max,bins,m,c);
-  if (bins[k-1  ].mask == m) MakeCluster(k-1  ,max,bins,m,c);
-  if (bins[k+max].mask == m) MakeCluster(k+max,max,bins,m,c);
-  if (bins[k+1  ].mask == m) MakeCluster(k+1  ,max,bins,m,c);
-}
+  amat[0]=12.011;
+  amat[1]=1.;
+  amat[2]=15.9994;
 
-//_____________________________________________________________________________
-void AliTPC::Digits2Clusters()
+  zmat[0]=6.;
+  zmat[1]=1.;
+  zmat[2]=8.;
+
+  wmat[0]=14.;
+  wmat[1]=20.;
+  wmat[2]=3.;
+
+  density=1.25;
+
+  AliMixture(45,"Epoxy",amat,zmat,density,-3,wmat);
+
+  // Carbon
+
+  amat[0]=12.011;
+  zmat[0]=6.;
+  density= 2.265;
+
+  AliMaterial(46,"C",amat[0],zmat[0],density,999.,999.);
+
+  // get epoxy
+
+  gMC->Gfmate((*fIdmate)[45],namate,amat[1],zmat[1],rho,X0,absl,buf,nbuf);
+
+  // Carbon fiber
+
+  wmat[0]=0.644; // by weight!
+  wmat[1]=0.356;
+
+  density=0.5*(1.25+2.265);
+
+  AliMixture(47,"Cfiber",amat,zmat,density,2,wmat);
+
+  // get SiO2
+
+  gMC->Gfmate((*fIdmate)[38],namate,amat[0],zmat[0],rho,X0,absl,buf,nbuf); 
+
+  wmat[0]=0.725; // by weight!
+  wmat[1]=0.275;
+
+  density=1.7;
+
+  AliMixture(39,"G10",amat,zmat,density,2,wmat);
+
+
+
+  //----------------------------------------------------------
+  // tracking media for gases
+  //----------------------------------------------------------
+
+  AliMedium(0, "Air", 24, 0, iSXFLD, sXMGMX, 10., 999., .1, .01, .1);
+  AliMedium(1, "Drift gas 1", 31, 0, iSXFLD, sXMGMX, 10., 999.,.1,.001, .001);
+  AliMedium(2, "Drift gas 2", 32, 1, iSXFLD, sXMGMX, 10., 999.,.1,.001, .001);
+  AliMedium(3,"CO2",10,0, iSXFLD, sXMGMX, 10., 999.,.1, .001, .001); 
+
+  //-----------------------------------------------------------  
+  // tracking media for solids
+  //-----------------------------------------------------------
+  
+  AliMedium(4,"Al",40,0, iSXFLD, sXMGMX, 10., 999., .1, .0005, .001);
+  AliMedium(5,"Kevlar",34,0, iSXFLD, sXMGMX, 10., 999., .1, .0005, .001);
+  AliMedium(6,"Nomex",35,0, iSXFLD, sXMGMX, 10., 999., .1, .001, .001);
+  AliMedium(7,"Makrolon",36,0, iSXFLD, sXMGMX, 10., 999., .1, .001, .001);
+  AliMedium(8,"Mylar",37,0, iSXFLD, sXMGMX, 10., 999., .1, .0005, .001);
+  AliMedium(9,"Tedlar",43,0, iSXFLD, sXMGMX, 10., 999., .1, .0005, .001);
+  AliMedium(10,"Cu",42,0, iSXFLD, sXMGMX, 10., 999., .1, .001, .001);
+  AliMedium(11,"Si",41,0, iSXFLD, sXMGMX, 10., 999., .1, .001, .001);
+  AliMedium(12,"G10",39,0, iSXFLD, sXMGMX, 10., 999., .1, .001, .001);
+  AliMedium(13,"Plexiglas",44,0, iSXFLD, sXMGMX, 10., 999., .1, .001, .001);
+  AliMedium(14,"Epoxy",45,0, iSXFLD, sXMGMX, 10., 999., .1, .0005, .001);
+  AliMedium(15,"Cfiber",47,0, iSXFLD, sXMGMX, 10., 999., .1, .001, .001);
+    
+}
+
+void AliTPC::GenerNoise(Int_t tablesize)
 {
-  //-----------------------------------------------------------------
-  // This is a simple cluster finder.
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  AliTPCParam *par = fTPCParam;
-  const Int_t MAXZ=par->GetMaxTBin()+2;
+  //Generate table with noise
+  //
+  if (fTPCParam==0) {
+    // error message
+    fNoiseDepth=0;
+    return;
+  }
+  if (fNoiseTable)  delete[] fNoiseTable;
+  fNoiseTable = new Float_t[tablesize];
+  fNoiseDepth = tablesize; 
+  fCurrentNoise =0; //!index of the noise in  the noise table 
+  
+  Float_t norm = fTPCParam->GetNoise()*fTPCParam->GetNoiseNormFac();
+  for (Int_t i=0;i<tablesize;i++) fNoiseTable[i]= gRandom->Gaus(0,norm);      
+}
 
-  TTree *t = (TTree *)gDirectory->Get("TreeD_75x40_100x60");
-  AliSimDigits digarr, *dummy=&digarr;
-  t->GetBranch("Segment")->SetAddress(&dummy);
-  Stat_t sectors_by_rows = t->GetEntries();
-  for (Int_t n=0; n<sectors_by_rows; n++) {
-    t->GetEvent(n);
-    Int_t sec, row;
-    if (!par->AdjustSectorRow(digarr.GetID(),sec,row)) {
-       cerr<<"AliTPC warning: invalid segment ID ! "<<digarr.GetID()<<endl;
-       continue;
-    }
+Float_t AliTPC::GetNoise()
+{
+  // get noise from table
+  //  if ((fCurrentNoise%10)==0) 
+  //  fCurrentNoise= gRandom->Rndm()*fNoiseDepth;
+  if (fCurrentNoise>=fNoiseDepth) fCurrentNoise=0;
+  return fNoiseTable[fCurrentNoise++];
+  //gRandom->Gaus(0, fTPCParam->GetNoise()*fTPCParam->GetNoiseNormFac()); 
+}
 
-    Float_t rx=par->GetPadRowRadii(sec,row);
 
-    Int_t npads, sign;
-    {
-       Int_t nis=par->GetNInnerSector(), nos=par->GetNOuterSector();
-       if (sec < nis) {
-          npads = par->GetNPadsLow(row);
-          sign = (sec < nis/2) ? 1 : -1;
-       } else {
-          npads = par->GetNPadsUp(row);
-          sign = ((sec-nis) < nos/2) ? 1 : -1;
-       }
-    }
+Bool_t  AliTPC::IsSectorActive(Int_t sec)
+{
+  //
+  // check if the sector is active
+  if (!fActiveSectors) return kTRUE;
+  else return fActiveSectors[sec]; 
+}
 
-    const Int_t MAXBIN=MAXZ*(npads+2);
-    Bin *bins=new Bin[MAXBIN];
-
-    digarr.First();
-    do {
-       Short_t dig=digarr.CurrentDigit();
-       if (dig<=par->GetZeroSup()) continue;
-       Int_t j=digarr.CurrentRow()+1, i=digarr.CurrentColumn()+1;
-       bins[i*MAXZ+j].q=dig;
-       bins[i*MAXZ+j].mask=1;
-    } while (digarr.Next());
-
-    Int_t ncl=0;
-    for (Int_t i=0; i<MAXBIN; i++) {
-      if ((bins[i].mask&1) == 0) continue;
-      Peak peaks[32]; Int_t npeaks=0;
-      FindPeaks(i, MAXZ, bins, peaks, npeaks);
-
-      if (npeaks>30) continue;
-
-      Int_t k,l;
-      for (k=0; k<npeaks-1; k++){//mark adjacent peaks
-        if (peaks[k].k < 0) continue; //this peak is already removed
-        for (l=k+1; l<npeaks; l++) {
-           if (peaks[l].k < 0) continue; //this peak is already removed
-           Int_t ki=peaks[k].k/MAXZ, kj=peaks[k].k - ki*MAXZ;
-           Int_t li=peaks[l].k/MAXZ, lj=peaks[l].k - li*MAXZ;
-           Int_t di=TMath::Abs(ki - li);
-           Int_t dj=TMath::Abs(kj - lj);
-           if (di>1 || dj>1) continue;
-           if (bins[peaks[k].k].q > bins[peaks[l].k].q) {
-              peaks[l].mask=peaks[k].mask;
-              peaks[l].k*=-1;
-           } else {
-              peaks[k].mask=peaks[l].mask;
-              peaks[k].k*=-1;
-              break;
-           } 
-        }
-      }
+void    AliTPC::SetActiveSectors(Int_t * sectors, Int_t n)
+{
+  // activate interesting sectors
+  SetTreeAddress();//just for security
+  if (fActiveSectors) delete [] fActiveSectors;
+  fActiveSectors = new Bool_t[fTPCParam->GetNSector()];
+  for (Int_t i=0;i<fTPCParam->GetNSector();i++) fActiveSectors[i]=kFALSE;
+  for (Int_t i=0;i<n;i++) 
+    if ((sectors[i]>=0) && sectors[i]<fTPCParam->GetNSector())  fActiveSectors[sectors[i]]=kTRUE;
+    
+}
 
-      for (k=0; k<npeaks; k++) {
-        MarkPeak(TMath::Abs(peaks[k].k), MAXZ, bins, peaks[k].mask);
-      }
-        
-      for (k=0; k<npeaks; k++) {
-         if (peaks[k].k < 0) continue; //removed peak
-         AliTPCcluster c;
-         MakeCluster(peaks[k].k, MAXZ, bins, peaks[k].mask, c);
-         if (c.fQ < 5) continue; //noise cluster
-         c.fY /= c.fQ;
-         c.fZ /= c.fQ;
-
-         Double_t s2 = c.fSigmaY2/c.fQ - c.fY*c.fY;
-         c.fSigmaY2 = s2 + 1./12.;
-         c.fSigmaY2 *= par->GetPadPitchWidth(sec)*par->GetPadPitchWidth(sec);
-         if (s2 != 0.) {
-            c.fSigmaY2 *= 0.064*1.3*1.3;
-            if (sec<par->GetNInnerSector()) c.fSigmaY2 *= 1.44*1.44;
-         }
-
-         s2 = c.fSigmaZ2/c.fQ - c.fZ*c.fZ;
-         c.fSigmaZ2 = s2 + 1./12.;
-         c.fSigmaZ2 *= par->GetZWidth()*par->GetZWidth();
-         if (s2 != 0.) {
-            c.fSigmaZ2 *= 0.10*1.3*1.3;
-            if (sec<par->GetNInnerSector()) c.fSigmaZ2 *= 1.33*1.33;
-         }
-
-         c.fY = (c.fY - 0.5 - 0.5*npads)*par->GetPadPitchWidth(sec);
-         c.fZ = par->GetZWidth()*(c.fZ-1); 
-         c.fZ -= 3.*par->GetZSigma(); // PASA delay 
-         c.fZ = sign*(z_end - c.fZ);
-
-         if (rx<230./250.*TMath::Abs(c.fZ)) continue;
-
-         c.fSector=sec;
-         c.fPadRow=row;
-         Int_t ki=peaks[k].k/MAXZ, kj=peaks[k].k - ki*MAXZ;
-         c.fTracks[0]=digarr.GetTrackID(kj-1,ki-1,0);
-         c.fTracks[1]=digarr.GetTrackID(kj-1,ki-1,1);
-         c.fTracks[2]=digarr.GetTrackID(kj-1,ki-1,2);
-
-         c.fQ=bins[peaks[k].k].q;
-
-         if (ki==1 || ki==npads || kj==1 || kj==MAXZ-2) {
-           c.fSigmaY2 *= 25.;
-           c.fSigmaZ2 *= 4.;
-         }
-
-         AddCluster(c); ncl++;
-      }
+void    AliTPC::SetActiveSectors(Int_t flag)
+{
+  //
+  // activate sectors which were hitted by tracks 
+  //loop over tracks
+  SetTreeAddress();//just for security
+  if (fHitType==0) return;  // if Clones hit - not short volume ID information
+  if (fActiveSectors) delete [] fActiveSectors;
+  fActiveSectors = new Bool_t[fTPCParam->GetNSector()];
+  if (flag) {
+    for (Int_t i=0;i<fTPCParam->GetNSector();i++) fActiveSectors[i]=kTRUE;
+    return;
+  }
+  for (Int_t i=0;i<fTPCParam->GetNSector();i++) fActiveSectors[i]=kFALSE;
+  TBranch * branch=0;
+  if (TreeH() == 0x0)
+   {
+     Fatal("SetActiveSectors","Can not find TreeH in folder");
+     return;
+   }
+  if (fHitType>1) branch = TreeH()->GetBranch("TPC2");
+  else branch = TreeH()->GetBranch("TPC");
+  Stat_t ntracks = TreeH()->GetEntries();
+  // loop over all hits
+  cout<<"\nAliTPC::SetActiveSectors():  Got "<<ntracks<<" tracks\n";
+  
+  for(Int_t track=0;track<ntracks;track++)
+   {
+    ResetHits();
+    //
+    if (fTrackHits && fHitType&4) {
+      TBranch * br1 = TreeH()->GetBranch("fVolumes");
+      TBranch * br2 = TreeH()->GetBranch("fNVolumes");
+      br1->GetEvent(track);
+      br2->GetEvent(track);
+      Int_t *volumes = fTrackHits->GetVolumes();
+      for (Int_t j=0;j<fTrackHits->GetNVolumes(); j++)
+       fActiveSectors[volumes[j]]=kTRUE;
     }
-
-    cerr<<"sector, row, compressed digits, clusters: "
-    <<sec<<' '<<row<<' '<<digarr.GetSize()<<' '<<ncl<<"                  \r";
-        
-    delete[] bins;  
+    
+    //
+    if (fTrackHitsOld && fHitType&2) {
+      TBranch * br = TreeH()->GetBranch("fTrackHitsInfo");
+      br->GetEvent(track);
+      AliObjectArray * ar = fTrackHitsOld->fTrackHitsInfo;
+      for (UInt_t j=0;j<ar->GetSize();j++){
+       fActiveSectors[((AliTrackHitsInfo*)ar->At(j))->fVolumeID] =kTRUE;
+      } 
+    }    
   }
+  
+}  
+
+
+
+
+void AliTPC::Digits2Clusters(Int_t /*eventnumber*/)
+{
+  //-----------------------------------------------------------------
+  // This is a simple cluster finder.
+  //-----------------------------------------------------------------
+  Error("Digits2Clusters",
+  "Dummy function !  Call AliTPCclusterer::Digits2Clusters(...) instead !");
 }
 
+extern Double_t SigmaY2(Double_t, Double_t, Double_t);
+extern Double_t SigmaZ2(Double_t, Double_t);
 //_____________________________________________________________________________
-void AliTPC::Hits2Clusters()
+void AliTPC::Hits2Clusters(Int_t /*eventn*/)
 {
   //--------------------------------------------------------
   // TPC simple cluster generator from hits
@@ -1137,18 +855,40 @@ void AliTPC::Hits2Clusters()
   //-----------------------------------------------------------------
   // Origin: Marek Kowalski  IFJ, Krakow, Marek.Kowalski@ifj.edu.pl
   //-----------------------------------------------------------------
+  // Adopted to Marian's cluster data structure by I.Belikov, CERN,
+  // Jouri.Belikov@cern.ch
+  //----------------------------------------------------------------
+  
+  /////////////////////////////////////////////////////////////////////////////
+  //
+  //---------------------------------------------------------------------
+  //   ALICE TPC Cluster Parameters
+  //--------------------------------------------------------------------
+       
+  
+
+  // Cluster width in rphi
+  const Float_t kACrphi=0.18322;
+  const Float_t kBCrphi=0.59551e-3;
+  const Float_t kCCrphi=0.60952e-1;
+  // Cluster width in z
+  const Float_t kACz=0.19081;
+  const Float_t kBCz=0.55938e-3;
+  const Float_t kCCz=0.30428;
 
-   if(fTPCParam == 0){
-     printf("AliTPCParam MUST be created firstly\n");
+
+  if (!fLoader) {
+     cerr<<"AliTPC::Hits2Clusters(): output file not open !\n";
      return;
-   }
+  }
+
+  //if(fDefaults == 0) SetDefaults();
 
-  Float_t sigma_rphi,sigma_z,cl_rphi,cl_z;
+  Float_t sigmaRphi,sigmaZ,clRphi,clZ;
   //
   TParticle *particle; // pointer to a given particle
   AliTPChit *tpcHit; // pointer to a sigle TPC hit
-  TClonesArray *Particles; //pointer to the particle list
-  Int_t sector,nhits;
+  Int_t sector;
   Int_t ipart;
   Float_t xyz[5];
   Float_t pl,pt,tanth,rpad,ratio;
@@ -1158,8 +898,32 @@ void AliTPC::Hits2Clusters()
   //  Get the access to the tracks 
   //---------------------------------------------------------------
   
-  TTree *TH = gAlice->TreeH();
-  Stat_t ntracks = TH->GetEntries();
+  TTree *tH = TreeH();
+  if (tH == 0x0)
+   {
+     Fatal("Hits2Clusters","Can not find TreeH in folder");
+     return;
+   }
+  SetTreeAddress();
+  
+  Stat_t ntracks = tH->GetEntries();
+
+  //Switch to the output file
+  
+  if (fLoader->TreeR() == 0x0) fLoader->MakeTree("R");
+  
+  cout<<"fTPCParam->GetTitle() = "<<fTPCParam->GetTitle()<<endl;
+  
+  AliRunLoader* rl = (AliRunLoader*)fLoader->GetEventFolder()->FindObject(AliRunLoader::fgkRunLoaderName);
+  rl->CdGAFile();
+  //fTPCParam->Write(fTPCParam->GetTitle());
+
+  AliTPCClustersArray carray;
+  carray.Setup(fTPCParam);
+  carray.SetClusterType("AliTPCcluster");
+  carray.MakeTree(fLoader->TreeR());
+
+  Int_t nclusters=0; //cluster counter
   
   //------------------------------------------------------------
   // Loop over all sectors (72 sectors for 20 deg
@@ -1180,47 +944,52 @@ void AliTPC::Hits2Clusters()
     
     for(Int_t track=0;track<ntracks;track++){
       ResetHits();
-      TH->GetEvent(track);
-      //
-      //  Get number of the TPC hits and a pointer
-      //  to the particles
-      //
-      nhits=fHits->GetEntriesFast();
-      Particles=gAlice->Particles();
+      tH->GetEvent(track);
       //
+      //  Get number of the TPC hits
+      //     
+       tpcHit = (AliTPChit*)FirstHit(-1);
+
       // Loop over hits
       //
-      for(Int_t hit=0;hit<nhits;hit++){
-       tpcHit=(AliTPChit*)fHits->UncheckedAt(hit);
-        if (tpcHit->fQ == 0.) continue; //information about track (I.Belikov)
+       while(tpcHit){
+        if (tpcHit->fQ == 0.) {
+           tpcHit = (AliTPChit*) NextHit();
+           continue; //information about track (I.Belikov)
+        }
        sector=tpcHit->fSector; // sector number
-       if(sector != isec) continue; //terminate iteration
-       ipart=tpcHit->fTrack;
-       particle=(TParticle*)Particles->UncheckedAt(ipart);
+
+       if(sector != isec){
+        tpcHit = (AliTPChit*) NextHit();
+        continue; 
+       }
+       ipart=tpcHit->Track();
+       particle=gAlice->Particle(ipart);
        pl=particle->Pz();
        pt=particle->Pt();
        if(pt < 1.e-9) pt=1.e-9;
        tanth=pl/pt;
        tanth = TMath::Abs(tanth);
-       rpad=TMath::Sqrt(tpcHit->fX*tpcHit->fX + tpcHit->fY*tpcHit->fY);
+       rpad=TMath::Sqrt(tpcHit->X()*tpcHit->X() + tpcHit->Y()*tpcHit->Y());
        ratio=0.001*rpad/pt; // pt must be in MeV/c - historical reason
-       
+
        //   space-point resolutions
        
-       sigma_rphi=SigmaY2(rpad,tanth,pt);
-       sigma_z   =SigmaZ2(rpad,tanth   );
+       sigmaRphi=SigmaY2(rpad,tanth,pt);
+       sigmaZ   =SigmaZ2(rpad,tanth   );
        
        //   cluster widths
        
-       cl_rphi=ac_rphi-bc_rphi*rpad*tanth+cc_rphi*ratio*ratio;
-       cl_z=ac_z-bc_z*rpad*tanth+cc_z*tanth*tanth;
+       clRphi=kACrphi-kBCrphi*rpad*tanth+kCCrphi*ratio*ratio;
+       clZ=kACz-kBCz*rpad*tanth+kCCz*tanth*tanth;
        
        // temporary protection
        
-       if(sigma_rphi < 0.) sigma_rphi=0.4e-3;
-       if(sigma_z < 0.) sigma_z=0.4e-3;
-       if(cl_rphi < 0.) cl_rphi=2.5e-3;
-       if(cl_z < 0.) cl_z=2.5e-5;
+       if(sigmaRphi < 0.) sigmaRphi=0.4e-3;
+       if(sigmaZ < 0.) sigmaZ=0.4e-3;
+       if(clRphi < 0.) clRphi=2.5e-3;
+       if(clZ < 0.) clZ=2.5e-5;
        
        //
        
@@ -1228,21 +997,47 @@ void AliTPC::Hits2Clusters()
        // smearing --> rotate to the 1 (13) or to the 25 (49) sector,
        // then the inaccuracy in a X-Y plane is only along Y (pad row)!
        //
-       //Float_t xprim= tpcHit->fX*cph + tpcHit->fY*sph;
-       Float_t yprim=-tpcHit->fX*sph + tpcHit->fY*cph;
-       xyz[0]=gRandom->Gaus(yprim,TMath::Sqrt(sigma_rphi));   // y
-       xyz[1]=gRandom->Gaus(tpcHit->fZ,TMath::Sqrt(sigma_z)); // z 
-       xyz[2]=tpcHit->fQ;                                     // q
-       xyz[3]=sigma_rphi;                                     // fSigmaY2
-       xyz[4]=sigma_z;                                        // fSigmaZ2
-       
-        Int_t tracks[5]={tpcHit->fTrack, -1, -1, sector, tpcHit->fPadRow};
-       AddCluster(xyz,tracks);
-       
+        Float_t xprim= tpcHit->X()*cph + tpcHit->Y()*sph;
+       Float_t yprim=-tpcHit->X()*sph + tpcHit->Y()*cph;
+       xyz[0]=gRandom->Gaus(yprim,TMath::Sqrt(sigmaRphi));   // y
+          Float_t alpha=(isec < fTPCParam->GetNInnerSector()) ?
+         fTPCParam->GetInnerAngle() : fTPCParam->GetOuterAngle();
+          Float_t ymax=xprim*TMath::Tan(0.5*alpha);
+          if (TMath::Abs(xyz[0])>ymax) xyz[0]=yprim; 
+       xyz[1]=gRandom->Gaus(tpcHit->Z(),TMath::Sqrt(sigmaZ)); // z
+          if (TMath::Abs(xyz[1])>fTPCParam->GetZLength()) xyz[1]=tpcHit->Z(); 
+       xyz[2]=sigmaRphi;                                     // fSigmaY2
+       xyz[3]=sigmaZ;                                        // fSigmaZ2
+       xyz[4]=tpcHit->fQ;                                    // q
+
+        AliTPCClustersRow *clrow=carray.GetRow(sector,tpcHit->fPadRow);
+        if (!clrow) clrow=carray.CreateRow(sector,tpcHit->fPadRow);    
+
+        Int_t tracks[3]={tpcHit->Track(), -1, -1};
+       AliTPCcluster cluster(tracks,xyz);
+
+        clrow->InsertCluster(&cluster); nclusters++;
+
+        tpcHit = (AliTPChit*)NextHit();
+        
+
       } // end of loop over hits
-    }   // end of loop over tracks     
-    
+
+    }   // end of loop over tracks
+
+    Int_t nrows=fTPCParam->GetNRow(isec);
+    for (Int_t irow=0; irow<nrows; irow++) {
+        AliTPCClustersRow *clrow=carray.GetRow(isec,irow);
+        if (!clrow) continue;
+        carray.StoreRow(isec,irow);
+        carray.ClearRow(isec,irow);
+    }
+
   } // end of loop over sectors  
+
+  cerr<<"Number of made clusters : "<<nclusters<<"                        \n";
+  fLoader->WriteRecPoints("OVERWRITE");
+  
   
 } // end of function
 
@@ -1264,13 +1059,12 @@ void AliTPC::Hits2ExactClustersSector(Int_t isec)
   //
   TParticle *particle; // pointer to a given particle
   AliTPChit *tpcHit; // pointer to a sigle TPC hit
-  TClonesArray *Particles; //pointer to the particle list
-  Int_t sector,nhits;
+  //  Int_t sector,nhits;
   Int_t ipart;
-  const Int_t cmaxhits=30000;
-  TVector * xxxx = new TVector(cmaxhits*4);
-  TVector & xxx = *xxxx;
-  Int_t maxhits = cmaxhits;
+  const Int_t kcmaxhits=30000;
+  AliTPCFastVector * xxxx = new AliTPCFastVector(kcmaxhits*4);
+  AliTPCFastVector & xxx = *xxxx;
+  Int_t maxhits = kcmaxhits;
   //construct array for each padrow
   for (Int_t i=0; i<fTPCParam->GetNRow(isec);i++) 
     fClustersArray->CreateRow(isec,i);
@@ -1279,46 +1073,64 @@ void AliTPC::Hits2ExactClustersSector(Int_t isec)
   //  Get the access to the tracks 
   //---------------------------------------------------------------
   
-  TTree *TH = gAlice->TreeH();
-  Stat_t ntracks = TH->GetEntries();
-  Particles=gAlice->Particles();
-  Int_t npart = Particles->GetEntriesFast();
-    
+  TTree *tH = TreeH();
+  if (tH == 0x0)
+   {
+     Fatal("Hits2Clusters","Can not find TreeH in folder");
+     return;
+   }
+  SetTreeAddress();
+
+  Stat_t ntracks = tH->GetEntries();
+  Int_t npart = gAlice->GetNtrack();
+  //MI change
+  TBranch * branch=0;
+  if (fHitType>1) branch = tH->GetBranch("TPC2");
+  else branch = tH->GetBranch("TPC");
+
   //------------------------------------------------------------
   // Loop over tracks
   //------------------------------------------------------------
-  
-  for(Int_t track=0;track<ntracks;track++){
+
+  for(Int_t track=0;track<ntracks;track++){ 
+    Bool_t isInSector=kTRUE;
     ResetHits();
-    TH->GetEvent(track);
+     isInSector = TrackInVolume(isec,track);
+    if (!isInSector) continue;
+    //MI change
+    branch->GetEntry(track); // get next track
     //
     //  Get number of the TPC hits and a pointer
     //  to the particles
-    //
-    nhits=fHits->GetEntriesFast();
-    //
     // Loop over hits
     //
     Int_t currentIndex=0;
     Int_t lastrow=-1;  //last writen row
-    for(Int_t hit=0;hit<nhits;hit++){
-      tpcHit=(AliTPChit*)fHits->UncheckedAt(hit);
-      if (tpcHit==0) continue;
-      sector=tpcHit->fSector; // sector number
-      if(sector != isec) continue; 
-      ipart=tpcHit->fTrack;
-      if (ipart<npart) particle=(TParticle*)Particles->UncheckedAt(ipart);
+
+    //M.I. changes
+
+    tpcHit = (AliTPChit*)FirstHit(-1);
+    while(tpcHit){
+      
+      Int_t sector=tpcHit->fSector; // sector number
+      if(sector != isec){
+       tpcHit = (AliTPChit*) NextHit();
+       continue; 
+      }
+
+      ipart=tpcHit->Track();
+      if (ipart<npart) particle=gAlice->Particle(ipart);
       
       //find row number
 
-      Float_t  x[3]={tpcHit->fX,tpcHit->fY,tpcHit->fZ};
+      Float_t  x[3]={tpcHit->X(),tpcHit->Y(),tpcHit->Z()};
       Int_t    index[3]={1,isec,0};
       Int_t    currentrow = fTPCParam->GetPadRow(x,index) ;    
-      if (currentrow<0) continue;
+      if (currentrow<0) {tpcHit = (AliTPChit*)NextHit(); continue;}
       if (lastrow<0) lastrow=currentrow;
       if (currentrow==lastrow){
        if ( currentIndex>=maxhits){
-         maxhits+=cmaxhits;
+         maxhits+=kcmaxhits;
          xxx.ResizeTo(4*maxhits);
        }     
        xxx(currentIndex*4)=x[0];
@@ -1358,7 +1170,7 @@ void AliTPC::Hits2ExactClustersSector(Int_t isec)
            sumx2z+=xxx(index*4+2)*x2;   
            sumq+=xxx(index*4+3);
          }
-         Float_t CentralPad = (fTPCParam->GetNPads(isec,lastrow)-1)/2;
+         Float_t centralPad = (fTPCParam->GetNPads(isec,lastrow)-1)/2;
          Float_t det=currentIndex*(sumx2*sumx4-sumx3*sumx3)-sumx*(sumx*sumx4-sumx2*sumx3)+
            sumx2*(sumx*sumx3-sumx2*sumx2);
          
@@ -1372,28 +1184,35 @@ void AliTPC::Hits2ExactClustersSector(Int_t isec)
          Float_t detbz=currentIndex*(sumxz*sumx4-sumx2z*sumx3)-sumz*(sumx*sumx4-sumx2*sumx3)+
            sumx2*(sumx*sumx2z-sumx2*sumxz);
          
-         Float_t y=detay/det+CentralPad;
+         if (TMath::Abs(det)<0.00001){
+            tpcHit = (AliTPChit*)NextHit();
+           continue;
+         }
+       
+         Float_t y=detay/det+centralPad;
          Float_t z=detaz/det;  
          Float_t by=detby/det; //y angle
          Float_t bz=detbz/det; //z angle
          sumy/=Float_t(currentIndex);
          sumz/=Float_t(currentIndex);
-         AliCluster cl;
-         cl.fX=z;
-         cl.fY=y;
-         cl.fQ=sumq;
-         cl.fSigmaX2=bz;
-         cl.fSigmaY2=by;
-         cl.fTracks[0]=ipart;
-         
+
          AliTPCClustersRow * row = (fClustersArray->GetRow(isec,lastrow));
-         if (row!=0) row->InsertCluster(&cl);
+         if (row!=0) {
+           AliComplexCluster* cl = new((AliComplexCluster*)row->Append()) AliComplexCluster ;
+           //    AliComplexCluster cl;
+           cl->fX=z;
+           cl->fY=y;
+           cl->fQ=sumq;
+           cl->fSigmaX2=bz;
+           cl->fSigmaY2=by;
+           cl->fTracks[0]=ipart;
+         }
          currentIndex=0;
          lastrow=currentrow;
        } //end of calculating cluster for given row
        
        
-       
+      tpcHit = (AliTPChit*)NextHit();
     } // end of loop over hits
   }   // end of loop over tracks 
   //write padrows to tree 
@@ -1405,24 +1224,386 @@ void AliTPC::Hits2ExactClustersSector(Int_t isec)
  
 }
 
+
+
+//__
+void AliTPC::SDigits2Digits2(Int_t /*eventnumber*/)  
+{
+  //create digits from summable digits
+  GenerNoise(500000); //create teble with noise
+
+  //conect tree with sSDigits
+  TTree *t = fLoader->TreeS();
+
+  if (t == 0x0) 
+   {
+     fLoader->LoadSDigits("READ");
+     t = fLoader->TreeS();
+     if (t == 0x0)
+      {
+        Error("SDigits2Digits2","Can not get input TreeS");
+        return;
+      }
+   }
+  
+  if (fLoader->TreeD() == 0x0) fLoader->MakeTree("D");
+  
+  AliSimDigits digarr, *dummy=&digarr;
+  TBranch* sdb = t->GetBranch("Segment");
+  if (sdb == 0x0)
+   {
+     Error("SDigits2Digits2","Can not find branch with segments in TreeS.");
+     return;
+   }  
+
+  sdb->SetAddress(&dummy);
+      
+  Stat_t nentries = t->GetEntries();
+
+  // set zero suppression
+
+  fTPCParam->SetZeroSup(2);
+
+  // get zero suppression
+
+  Int_t zerosup = fTPCParam->GetZeroSup();
+
+  //make tree with digits 
+  
+  AliTPCDigitsArray *arr = new AliTPCDigitsArray; 
+  arr->SetClass("AliSimDigits");
+  arr->Setup(fTPCParam);
+  arr->MakeTree(fLoader->TreeD());
+  
+  AliTPCParam * par = fTPCParam;
+
+  //Loop over segments of the TPC
+
+  for (Int_t n=0; n<nentries; n++) {
+    t->GetEvent(n);
+    Int_t sec, row;
+    if (!par->AdjustSectorRow(digarr.GetID(),sec,row)) {
+      cerr<<"AliTPC warning: invalid segment ID ! "<<digarr.GetID()<<endl;
+      continue;
+    }
+    if (!IsSectorActive(sec)) 
+     {
+//       cout<<n<<" NOT Active \n";
+       continue;
+     }
+    else
+     {
+//       cout<<n<<" Active \n";
+     }
+    AliSimDigits * digrow =(AliSimDigits*) arr->CreateRow(sec,row);
+    Int_t nrows = digrow->GetNRows();
+    Int_t ncols = digrow->GetNCols();
+
+    digrow->ExpandBuffer();
+    digarr.ExpandBuffer();
+    digrow->ExpandTrackBuffer();
+    digarr.ExpandTrackBuffer();
+
+    
+    Short_t * pamp0 = digarr.GetDigits();
+    Int_t   * ptracks0 = digarr.GetTracks();
+    Short_t * pamp1 = digrow->GetDigits();
+    Int_t   * ptracks1 = digrow->GetTracks();
+    Int_t  nelems =nrows*ncols;
+    Int_t saturation = fTPCParam->GetADCSat();
+    //use internal structure of the AliDigits - for speed reason
+    //if you cahnge implementation
+    //of the Alidigits - it must be rewriten -
+    for (Int_t i= 0; i<nelems; i++){
+      //      Float_t q = *pamp0;
+      //q/=16.;  //conversion faktor
+      //Float_t noise= GetNoise(); 
+      //q+=noise;      
+      //q= TMath::Nint(q);
+      Float_t q = TMath::Nint(Float_t(*pamp0)/16.+GetNoise());
+      if (q>zerosup){
+       if (q>saturation) q=saturation;      
+       *pamp1=(Short_t)q;
+       //if (ptracks0[0]==0)
+       //  ptracks1[0]=1;
+       //else
+       ptracks1[0]=ptracks0[0];        
+       ptracks1[nelems]=ptracks0[nelems];
+       ptracks1[2*nelems]=ptracks0[2*nelems];
+      }
+      pamp0++;
+      pamp1++;
+      ptracks0++;
+      ptracks1++;       
+    }
+
+    arr->StoreRow(sec,row);
+    arr->ClearRow(sec,row);   
+    // cerr<<sec<<"\t"<<row<<"\n";   
+  }  
+
+    
+  //write results
+  fLoader->WriteDigits("OVERWRITE");
+   
+  delete arr;
+}
+//__________________________________________________________________
+void AliTPC::SetDefaults(){
+
+   
+   cerr<<"Setting default parameters...\n";
+
+  // Set response functions
+
+  //
+  AliRunLoader* rl = (AliRunLoader*)fLoader->GetEventFolder()->FindObject(AliRunLoader::fgkRunLoaderName);
+  rl->CdGAFile();
+  AliTPCParamSR *param=(AliTPCParamSR*)gDirectory->Get("75x40_100x60");
+  if(param){
+    printf("You are using 2 pad-length geom hits with 3 pad-lenght geom digits...\n");
+    delete param;
+    param = new AliTPCParamSR();
+  }
+  else {
+    param=(AliTPCParamSR*)gDirectory->Get("75x40_100x60_150x60");
+  }
+  if(!param){
+    printf("No TPC parameters found\n");
+    exit(4);
+  }
+
+
+  AliTPCPRF2D    * prfinner   = new AliTPCPRF2D;
+  AliTPCPRF2D    * prfouter1   = new AliTPCPRF2D;
+  AliTPCPRF2D    * prfouter2   = new AliTPCPRF2D;  
+  AliTPCRF1D     * rf    = new AliTPCRF1D(kTRUE);
+  rf->SetGauss(param->GetZSigma(),param->GetZWidth(),1.);
+  rf->SetOffset(3*param->GetZSigma());
+  rf->Update();
+  
+  TDirectory *savedir=gDirectory;
+  TFile *f=TFile::Open("$ALICE_ROOT/TPC/AliTPCprf2d.root");
+  if (!f->IsOpen()) { 
+    cerr<<"Can't open $ALICE_ROOT/TPC/AliTPCprf2d.root !\n" ;
+     exit(3);
+  }
+  prfinner->Read("prf_07504_Gati_056068_d02");
+  prfouter1->Read("prf_10006_Gati_047051_d03");
+  prfouter2->Read("prf_15006_Gati_047051_d03");  
+  f->Close();
+  savedir->cd();
+
+  param->SetInnerPRF(prfinner);
+  param->SetOuter1PRF(prfouter1); 
+  param->SetOuter2PRF(prfouter2);
+  param->SetTimeRF(rf);
+
+  // set fTPCParam
+
+  SetParam(param);
+
+
+  fDefaults = 1;
+
+}
 //__________________________________________________________________  
-void AliTPC::Hits2Digits()  
+void AliTPC::Hits2Digits(Int_t eventnumber)  
 { 
  //----------------------------------------------------
- // Loop over all sectors
+ // Loop over all sectors for a single event
  //----------------------------------------------------
+  AliRunLoader* rl = (AliRunLoader*)fLoader->GetEventFolder()->FindObject(AliRunLoader::fgkRunLoaderName);
+  rl->GetEvent(eventnumber);
+  if (fLoader->TreeH() == 0x0)
+   {
+     if(fLoader->LoadHits())
+      {
+        Error("Hits2Digits","Can not load hits.");
+      }
+   }
+  SetTreeAddress();
+  
+  if (fLoader->TreeD() == 0x0 ) 
+   {
+     fLoader->MakeTree("D");
+     if (fLoader->TreeD() == 0x0 ) 
+      {
+       Error("Hits2Digits","Can not get TreeD");
+       return;
+      }
+   }
 
-  if(fTPCParam == 0){
-    printf("AliTPCParam MUST be created firstly\n");
-    return;
-  } 
+  if(fDefaults == 0) SetDefaults();  // check if the parameters are set
+  GenerNoise(500000); //create teble with noise
+
+  //setup TPCDigitsArray 
+
+  if(GetDigitsArray()) delete GetDigitsArray();
+
+  AliTPCDigitsArray *arr = new AliTPCDigitsArray; 
+  arr->SetClass("AliSimDigits");
+  arr->Setup(fTPCParam);
+
+  arr->MakeTree(fLoader->TreeD());
+  SetDigitsArray(arr);
+
+  fDigitsSwitch=0; // standard digits
+
+  cerr<<"Digitizing TPC -- normal digits...\n";
+
+ for(Int_t isec=0;isec<fTPCParam->GetNSector();isec++) 
+  if (IsSectorActive(isec)) 
+   {
+    if (fDebug) Info("Hits2Digits","Sector %d is active.",isec);
+    Hits2DigitsSector(isec);
+   }
+  else
+   {
+    if (fDebug) Info("Hits2Digits","Sector %d is NOT active.",isec);
+   }
+
+  fLoader->WriteDigits("OVERWRITE"); 
+  
+//this line prevents the crash in the similar one
+//on the beginning of this method
+//destructor attempts to reset the tree, which is deleted by the loader
+//need to be redesign
+ if(GetDigitsArray()) delete GetDigitsArray();
+ SetDigitsArray(0x0);
+  
+}
+
+//__________________________________________________________________
+void AliTPC::Hits2SDigits2(Int_t eventnumber)  
+{ 
+
+  //-----------------------------------------------------------
+  //   summable digits - 16 bit "ADC", no noise, no saturation
+  //-----------------------------------------------------------
+
+ //----------------------------------------------------
+ // Loop over all sectors for a single event
+ //----------------------------------------------------
+//  AliRunLoader* rl = (AliRunLoader*)fLoader->GetEventFolder()->FindObject(AliRunLoader::fgkRunLoaderName);
+
+  AliRunLoader* rl = fLoader->GetRunLoader();
+
+  rl->GetEvent(eventnumber);
+  if (fLoader->TreeH() == 0x0)
+   {
+     if(fLoader->LoadHits())
+      {
+        Error("Hits2Digits","Can not load hits.");
+        return;
+      }
+   }
+  SetTreeAddress();
+
+
+  if (fLoader->TreeS() == 0x0 ) 
+   {
+     fLoader->MakeTree("S");
+   }
+  
+  if(fDefaults == 0) SetDefaults();
+  
+  GenerNoise(500000); //create table with noise
+  //setup TPCDigitsArray 
 
for(Int_t isec=0;isec<fTPCParam->GetNSector();isec++) Hits2DigitsSector(isec);
 if(GetDigitsArray()) delete GetDigitsArray();
 
+  
+  AliTPCDigitsArray *arr = new AliTPCDigitsArray; 
+  arr->SetClass("AliSimDigits");
+  arr->Setup(fTPCParam);
+  arr->MakeTree(fLoader->TreeS());
+
+  SetDigitsArray(arr);
+
+  cerr<<"Digitizing TPC -- summable digits...\n"; 
+
+  fDigitsSwitch=1; // summable digits
+  
+    // set zero suppression to "0"
+
+  fTPCParam->SetZeroSup(0);
+
+ for(Int_t isec=0;isec<fTPCParam->GetNSector();isec++) 
+  if (IsSectorActive(isec)) 
+   {
+//    cout<<"Sector "<<isec<<" is active\n";
+    Hits2DigitsSector(isec);
+   }
+
+ fLoader->WriteSDigits("OVERWRITE");
+
+//this line prevents the crash in the similar one
+//on the beginning of this method
+//destructor attempts to reset the tree, which is deleted by the loader
+//need to be redesign
+ if(GetDigitsArray()) delete GetDigitsArray();
+ SetDigitsArray(0x0);
 }
+//__________________________________________________________________
+
+void AliTPC::Hits2SDigits()  
+{ 
+
+  //-----------------------------------------------------------
+  //   summable digits - 16 bit "ADC", no noise, no saturation
+  //-----------------------------------------------------------
+
+ //----------------------------------------------------
+ // Loop over all sectors for a single event
+ //----------------------------------------------------
+  //MI change - for pp run
+//  Int_t eventnumber = gAlice->GetEvNumber();
+//  AliRunLoader* rl = (AliRunLoader*)fLoader->GetEventFolder()->FindObject(AliRunLoader::fgkRunLoaderName);
+//  rl->GetEvent(eventnumber);
+// 12/05/2003 This method is obsolete and not used. It should be redesingned
+// M.Kowalski
+
+  if (fLoader->TreeH() == 0x0)
+   {
+     if(fLoader->LoadHits())
+      {
+        Error("Hits2Digits","Can not load hits.");
+      }
+   }
+  SetTreeAddress();
+
+  if(fDefaults == 0) SetDefaults();
+  GenerNoise(500000); //create table with noise
+
+  //setup TPCDigitsArray 
+
+  if(GetDigitsArray()) delete GetDigitsArray();
+
+  if (fLoader->TreeS() == 0x0 ) 
+   {
+     fLoader->MakeTree("S");
+   }
+  
+  AliTPCDigitsArray *arr = new AliTPCDigitsArray; 
+  arr->SetClass("AliSimDigits");
+  arr->Setup(fTPCParam);
+  arr->MakeTree(fLoader->TreeS());
+  SetDigitsArray(arr);
 
+  cerr<<"Digitizing TPC -- summable digits...\n"; 
 
+  //  fDigitsSwitch=1; // summable digits  -for the moment direct
+
+  for(Int_t isec=0;isec<fTPCParam->GetNSector();isec++) if (IsSectorActive(isec)) Hits2DigitsSector(isec);
+
+  // write results
+  //
+  cout<<"Why method TPC::Hits2SDigits writes digits and not sdigits? skowron\n";
+  fLoader->WriteDigits("OVERWRITE");
+}
 //_____________________________________________________________________________
+
 void AliTPC::Hits2DigitsSector(Int_t isec)
 {
   //-------------------------------------------------------------------
@@ -1437,9 +1618,19 @@ void AliTPC::Hits2DigitsSector(Int_t isec)
   //  Get the access to the track hits
   //-------------------------------------------------------
 
+  // check if the parameters are set - important if one calls this method
+  // directly, not from the Hits2Digits
+
+  if(fDefaults == 0) SetDefaults();
+
+  TTree *tH = TreeH(); // pointer to the hits tree
+  if (tH == 0x0)
+   {
+     Fatal("Hits2DigitsSector","Can not find TreeH in folder");
+     return;
+   }
 
-  TTree *TH = gAlice->TreeH(); // pointer to the hits tree
-  Stat_t ntracks = TH->GetEntries();
+  Stat_t ntracks = tH->GetEntries();
 
   if( ntracks > 0){
 
@@ -1449,24 +1640,27 @@ void AliTPC::Hits2DigitsSector(Int_t isec)
 
     TObjArray **row;
     
-      printf("*** Processing sector number %d ***\n",isec);
+    //printf("*** Processing sector number %d ***\n",isec);
 
       Int_t nrows =fTPCParam->GetNRow(isec);
 
-      row= new TObjArray* [nrows];
+      row= new TObjArray* [nrows+2]; // 2 extra rows for cross talk
     
-      MakeSector(isec,nrows,TH,ntracks,row);
+      MakeSector(isec,nrows,tH,ntracks,row);
 
       //--------------------------------------------------------
       //   Digitize this sector, row by row
-      //   row[i] is the pointer to the TObjArray of TVectors,
+      //   row[i] is the pointer to the TObjArray of AliTPCFastVectors,
       //   each one containing electrons accepted on this
       //   row, assigned into tracks
       //--------------------------------------------------------
 
       Int_t i;
 
-      if (fDigitsArray->GetTree()==0) fDigitsArray->MakeTree();
+      if (fDigitsArray->GetTree()==0) 
+       {
+         Fatal("Hits2DigitsSector","Tree not set in fDigitsArray");
+       }
 
       for (i=0;i<nrows;i++){
 
@@ -1476,17 +1670,19 @@ void AliTPC::Hits2DigitsSector(Int_t isec)
 
        fDigitsArray->StoreRow(isec,i);
 
-       Int_t ndig = dig->GetSize(); 
-       printf("*** Sector, row, compressed digits %d %d %d ***\n",isec,i,ndig);
+       Int_t ndig = dig->GetDigitSize(); 
        
+       if (gDebug > 10) 
+       printf("*** Sector, row, compressed digits %d %d %d ***\n",isec,i,ndig);        
+       
         fDigitsArray->ClearRow(isec,i);  
 
    
        } // end of the sector digitization
 
-      for(i=0;i<nrows;i++){
-        row[i]->Delete();     
+      for(i=0;i<nrows+2;i++){
+        row[i]->Delete();  
+        delete row[i];   
       }
       
        delete [] row; // delete the array of pointers to TObjArray-s
@@ -1511,72 +1707,84 @@ void AliTPC::DigitizeRow(Int_t irow,Int_t isec,TObjArray **rows)
  
 
   Float_t zerosup = fTPCParam->GetZeroSup();
-  Int_t nrows =fTPCParam->GetNRow(isec);
+  //  Int_t nrows =fTPCParam->GetNRow(isec);
   fCurrentIndex[1]= isec;
   
 
-  Int_t n_of_pads = fTPCParam->GetNPads(isec,irow);
-  Int_t n_of_tbins = fTPCParam->GetMaxTBin();
-  Int_t IndexRange[4];
+  Int_t nofPads = fTPCParam->GetNPads(isec,irow);
+  Int_t nofTbins = fTPCParam->GetMaxTBin();
+  Int_t indexRange[4];
   //
   //  Integrated signal for this row
   //  and a single track signal
   //    
-  TMatrix *m1   = new TMatrix(0,n_of_pads,0,n_of_tbins); // integrated
-  TMatrix *m2   = new TMatrix(0,n_of_pads,0,n_of_tbins); // single
+
+  AliTPCFastMatrix *m1 = new AliTPCFastMatrix(0,nofPads,0,nofTbins); // integrated
+  AliTPCFastMatrix *m2 = new AliTPCFastMatrix(0,nofPads,0,nofTbins); // single
   //
-  TMatrix &Total  = *m1;
+  AliTPCFastMatrix &total  = *m1;
 
   //  Array of pointers to the label-signal list
 
-  Int_t NofDigits = n_of_pads*n_of_tbins; // number of digits for this row
-  Float_t  **pList = new Float_t* [NofDigits]; 
+  Int_t nofDigits = nofPads*nofTbins; // number of digits for this row
+  Float_t  **pList = new Float_t* [nofDigits]; 
 
   Int_t lp;
   Int_t i1;   
-  for(lp=0;lp<NofDigits;lp++)pList[lp]=0; // set all pointers to NULL
+  for(lp=0;lp<nofDigits;lp++)pList[lp]=0; // set all pointers to NULL
   //
   //calculate signal 
   //
-  Int_t row1 = TMath::Max(irow-fTPCParam->GetNCrossRows(),0);
-  Int_t row2 = TMath::Min(irow+fTPCParam->GetNCrossRows(),nrows-1);
+  //Int_t row1 = TMath::Max(irow-fTPCParam->GetNCrossRows(),0);
+  //Int_t row2 = TMath::Min(irow+fTPCParam->GetNCrossRows(),nrows-1);
+  Int_t row1=irow;
+  Int_t row2=irow+2; 
   for (Int_t row= row1;row<=row2;row++){
     Int_t nTracks= rows[row]->GetEntries();
     for (i1=0;i1<nTracks;i1++){
       fCurrentIndex[2]= row;
-      fCurrentIndex[3]=irow;
-      if (row==irow){
+      fCurrentIndex[3]=irow+1;
+      if (row==irow+1){
        m2->Zero();  // clear single track signal matrix
-       Float_t TrackLabel = GetSignal(rows[row],i1,m2,m1,IndexRange); 
-       GetList(TrackLabel,n_of_pads,m2,IndexRange,pList);
+       Float_t trackLabel = GetSignal(rows[row],i1,m2,m1,indexRange); 
+       GetList(trackLabel,nofPads,m2,indexRange,pList);
       }
-      else   GetSignal(rows[row],i1,0,m1,IndexRange);
+      else   GetSignal(rows[row],i1,0,m1,indexRange);
     }
   }
          
   Int_t tracks[3];
 
   AliDigits *dig = fDigitsArray->GetRow(isec,irow);
-  for(Int_t ip=0;ip<n_of_pads;ip++){
-    for(Int_t it=0;it<n_of_tbins;it++){
+  Int_t gi=-1;
+  Float_t fzerosup = zerosup+0.5;
+  for(Int_t it=0;it<nofTbins;it++){
+    Float_t *pq = &(total.UncheckedAt(0,it));
+    for(Int_t ip=0;ip<nofPads;ip++){
+      gi++;
+      Float_t q=*pq;      
+      pq++;
+      if(fDigitsSwitch == 0){
+       q+=GetNoise();
+        if(q <=fzerosup) continue; // do not fill zeros
+        q = TMath::Nint(q);
+        if(q > fTPCParam->GetADCSat()) q = fTPCParam->GetADCSat();  // saturation
 
-      Float_t q = Total(ip,it);
-
-      Int_t gi =it*n_of_pads+ip; // global index
-
-      q = gRandom->Gaus(q,fTPCParam->GetNoise()*fTPCParam->GetNoiseNormFac()); 
-
-      q = (Int_t)q;
+      }
 
-      if(q <=zerosup) continue; // do not fill zeros
-      if(q > adc_sat) q = adc_sat;  // saturation
+      else {
+       if(q <= 0.) continue; // do not fill zeros
+       if(q>2000.) q=2000.;
+       q *= 16.;
+       q = TMath::Nint(q);
+      }
 
       //
       //  "real" signal or electronic noise (list = -1)?
       //    
 
       for(Int_t j1=0;j1<3;j1++){
-        tracks[j1] = (pList[gi]) ?(Int_t)(*(pList[gi]+j1)) : -1;
+       tracks[j1] = (pList[gi]) ?(Int_t)(*(pList[gi]+j1)) : -2;
       }
 
 //Begin_Html
@@ -1601,7 +1809,7 @@ void AliTPC::DigitizeRow(Int_t irow,Int_t isec,TObjArray **rows)
   //  This row has been digitized, delete nonused stuff
   //
 
-  for(lp=0;lp<NofDigits;lp++){
+  for(lp=0;lp<nofDigits;lp++){
     if(pList[lp]) delete [] pList[lp];
   }
   
@@ -1615,8 +1823,8 @@ void AliTPC::DigitizeRow(Int_t irow,Int_t isec,TObjArray **rows)
 
 //_____________________________________________________________________________
 
-Float_t AliTPC::GetSignal(TObjArray *p1, Int_t ntr, TMatrix *m1, TMatrix *m2,
-                          Int_t *IndexRange)
+Float_t AliTPC::GetSignal(TObjArray *p1, Int_t ntr, 
+             AliTPCFastMatrix *m1, AliTPCFastMatrix *m2,Int_t *indexRange)
 {
 
   //---------------------------------------------------------------
@@ -1630,24 +1838,22 @@ Float_t AliTPC::GetSignal(TObjArray *p1, Int_t ntr, TMatrix *m1, TMatrix *m2,
   // Modified: Marian Ivanov 
   //-----------------------------------------------------------------
 
-  TVector *tv;
-  tv = (TVector*)p1->At(ntr); // pointer to a track
-  TVector &v = *tv;
+  AliTPCFastVector *tv;
+
+  tv = (AliTPCFastVector*)p1->At(ntr); // pointer to a track
+  AliTPCFastVector &v = *tv;
   
   Float_t label = v(0);
-  Int_t CentralPad = (fTPCParam->GetNPads(fCurrentIndex[1],fCurrentIndex[3])-1)/2;
+  Int_t centralPad = (fTPCParam->GetNPads(fCurrentIndex[1],fCurrentIndex[3]-1)-1)/2;
 
   Int_t nElectrons = (tv->GetNrows()-1)/4;
-  IndexRange[0]=9999; // min pad
-  IndexRange[1]=-1; // max pad
-  IndexRange[2]=9999; //min time
-  IndexRange[3]=-1; // max time
-
-  //  Float_t IneffFactor = 0.5; // inefficiency in the gain close to the edge, as above
+  indexRange[0]=9999; // min pad
+  indexRange[1]=-1; // max pad
+  indexRange[2]=9999; //min time
+  indexRange[3]=-1; // max time
 
-  TMatrix &signal = *m1;
-  TMatrix &total = *m2;
+  AliTPCFastMatrix &signal = *m1;
+  AliTPCFastMatrix &total = *m2;
   //
   //  Loop over all electrons
   //
@@ -1656,22 +1862,28 @@ Float_t AliTPC::GetSignal(TObjArray *p1, Int_t ntr, TMatrix *m1, TMatrix *m2,
     Float_t aval =  v(idx+4);
     Float_t eltoadcfac=aval*fTPCParam->GetTotalNormFac(); 
     Float_t xyz[3]={v(idx+1),v(idx+2),v(idx+3)};
-    Int_t n = fTPCParam->CalcResponse(xyz,fCurrentIndex,fCurrentIndex[3]);
-    
-    if (n>0) for (Int_t i =0; i<n; i++){
-       Int_t *index = fTPCParam->GetResBin(i);        
-       Int_t pad=index[1]+CentralPad;  //in digit coordinates central pad has coordinate 0
-       if ( ( pad<(fTPCParam->GetNPads(fCurrentIndex[1],fCurrentIndex[3]))) && (pad>0)) {
+    Int_t n = ((AliTPCParamSR*)fTPCParam)->CalcResponseFast(xyz,fCurrentIndex,fCurrentIndex[3]);
+
+    Int_t *index = fTPCParam->GetResBin(0);  
+    Float_t *weight = & (fTPCParam->GetResWeight(0));
+
+    if (n>0) for (Int_t i =0; i<n; i++){       
+       Int_t pad=index[1]+centralPad;  //in digit coordinates central pad has coordinate 0
+
+         if (pad>=0){
         Int_t time=index[2];    
-        Float_t weight = fTPCParam->GetResWeight(i); //we normalise response to ADC channel
-        weight *= eltoadcfac;
+         Float_t qweight = *(weight)*eltoadcfac;
         
-        if (m1!=0) signal(pad,time)+=weight; 
-        total(pad,time)+=weight;
-        IndexRange[0]=TMath::Min(IndexRange[0],pad);
-        IndexRange[1]=TMath::Max(IndexRange[1],pad);
-        IndexRange[2]=TMath::Min(IndexRange[2],time);
-        IndexRange[3]=TMath::Max(IndexRange[3],time); 
+        if (m1!=0) signal.UncheckedAt(pad,time)+=qweight;
+         total.UncheckedAt(pad,time)+=qweight;
+        if (indexRange[0]>pad) indexRange[0]=pad;
+        if (indexRange[1]<pad) indexRange[1]=pad;
+        if (indexRange[2]>time) indexRange[2]=time;
+        if (indexRange[3]<time) indexRange[3]=time;
+
+        index+=3;
+        weight++;      
+
        }        
     }
   } // end of loop over electrons
@@ -1680,8 +1892,8 @@ Float_t AliTPC::GetSignal(TObjArray *p1, Int_t ntr, TMatrix *m1, TMatrix *m2,
 }
 
 //_____________________________________________________________________________
-void AliTPC::GetList(Float_t label,Int_t np,TMatrix *m,Int_t *IndexRange,
-                     Float_t **pList)
+void AliTPC::GetList(Float_t label,Int_t np,AliTPCFastMatrix *m,
+                     Int_t *indexRange, Float_t **pList)
 {
   //----------------------------------------------------------------------
   //  Updates the list of tracks contributing to digits for a given row
@@ -1691,12 +1903,12 @@ void AliTPC::GetList(Float_t label,Int_t np,TMatrix *m,Int_t *IndexRange,
   // Origin: Marek Kowalski  IFJ, Krakow, Marek.Kowalski@ifj.edu.pl
   //-----------------------------------------------------------------
 
-  TMatrix &signal = *m;
+  AliTPCFastMatrix &signal = *m;
 
   // lop over nonzero digits
 
-  for(Int_t it=IndexRange[2];it<IndexRange[3]+1;it++){
-    for(Int_t ip=IndexRange[0];ip<IndexRange[1]+1;ip++){
+  for(Int_t it=indexRange[2];it<indexRange[3]+1;it++){
+    for(Int_t ip=indexRange[0];ip<indexRange[1]+1;ip++){
 
 
         // accept only the contribution larger than 500 electrons (1/2 s_noise)
@@ -1704,36 +1916,36 @@ void AliTPC::GetList(Float_t label,Int_t np,TMatrix *m,Int_t *IndexRange,
         if(signal(ip,it)<0.5) continue; 
 
 
-        Int_t GlobalIndex = it*np+ip; // GlobalIndex starts from 0!
+        Int_t globalIndex = it*np+ip; // globalIndex starts from 0!
         
-        if(!pList[GlobalIndex]){
+        if(!pList[globalIndex]){
         
           // 
          // Create new list (6 elements - 3 signals and 3 labels),
          //
 
-          pList[GlobalIndex] = new Float_t [6];
+          pList[globalIndex] = new Float_t [6];
 
          // set list to -1 
 
-          *pList[GlobalIndex] = -1.;
-          *(pList[GlobalIndex]+1) = -1.;
-          *(pList[GlobalIndex]+2) = -1.;
-          *(pList[GlobalIndex]+3) = -1.;
-          *(pList[GlobalIndex]+4) = -1.;
-          *(pList[GlobalIndex]+5) = -1.;
+          *pList[globalIndex] = -1.;
+          *(pList[globalIndex]+1) = -1.;
+          *(pList[globalIndex]+2) = -1.;
+          *(pList[globalIndex]+3) = -1.;
+          *(pList[globalIndex]+4) = -1.;
+          *(pList[globalIndex]+5) = -1.;
 
 
-          *pList[GlobalIndex] = label;
-          *(pList[GlobalIndex]+3) = signal(ip,it);
+          *pList[globalIndex] = label;
+          *(pList[globalIndex]+3) = signal(ip,it);
         }
         else{
 
          // check the signal magnitude
 
-          Float_t highest = *(pList[GlobalIndex]+3);
-          Float_t middle = *(pList[GlobalIndex]+4);
-          Float_t lowest = *(pList[GlobalIndex]+5);
+          Float_t highest = *(pList[globalIndex]+3);
+          Float_t middle = *(pList[globalIndex]+4);
+          Float_t lowest = *(pList[globalIndex]+5);
 
          //
          //  compare the new signal with already existing list
@@ -1744,24 +1956,24 @@ void AliTPC::GetList(Float_t label,Int_t np,TMatrix *m,Int_t *IndexRange,
          //
 
           if (signal(ip,it)>highest){
-            *(pList[GlobalIndex]+5) = middle;
-            *(pList[GlobalIndex]+4) = highest;
-            *(pList[GlobalIndex]+3) = signal(ip,it);
+            *(pList[globalIndex]+5) = middle;
+            *(pList[globalIndex]+4) = highest;
+            *(pList[globalIndex]+3) = signal(ip,it);
 
-            *(pList[GlobalIndex]+2) = *(pList[GlobalIndex]+1);
-            *(pList[GlobalIndex]+1) = *pList[GlobalIndex];
-            *pList[GlobalIndex] = label;
+            *(pList[globalIndex]+2) = *(pList[globalIndex]+1);
+            *(pList[globalIndex]+1) = *pList[globalIndex];
+            *pList[globalIndex] = label;
          }
           else if (signal(ip,it)>middle){
-            *(pList[GlobalIndex]+5) = middle;
-            *(pList[GlobalIndex]+4) = signal(ip,it);
+            *(pList[globalIndex]+5) = middle;
+            *(pList[globalIndex]+4) = signal(ip,it);
 
-            *(pList[GlobalIndex]+2) = *(pList[GlobalIndex]+1);
-            *(pList[GlobalIndex]+1) = label;
+            *(pList[globalIndex]+2) = *(pList[globalIndex]+1);
+            *(pList[globalIndex]+1) = label;
          }
           else{
-            *(pList[GlobalIndex]+5) = signal(ip,it);
-            *(pList[GlobalIndex]+2) = label;
+            *(pList[globalIndex]+5) = signal(ip,it);
+            *(pList[globalIndex]+2) = label;
          }
         }
 
@@ -1791,18 +2003,28 @@ void AliTPC::MakeSector(Int_t isec,Int_t nrows,TTree *TH,
   Float_t xyz[4]; 
 
   AliTPChit *tpcHit; // pointer to a sigle TPC hit    
+  //MI change
+  TBranch * branch=0;
+  if (fHitType>1) branch = TH->GetBranch("TPC2");
+  else branch = TH->GetBranch("TPC");
+
  
   //----------------------------------------------
   // Create TObjArray-s, one for each row,
-  // each TObjArray will store the TVectors
-  // of electrons, one TVector per each track.
+  // each TObjArray will store the AliTPCFastVectors
+  // of electrons, one AliTPCFastVectors per each track.
   //---------------------------------------------- 
     
-  for(i=0; i<nrows; i++){
+  Int_t *nofElectrons = new Int_t [nrows+2]; // electron counter for each row
+  AliTPCFastVector **tracks = new AliTPCFastVector* [nrows+2]; //pointers to the track vectors
+
+  for(i=0; i<nrows+2; i++){
     row[i] = new TObjArray;
+    nofElectrons[i]=0;
+    tracks[i]=0;
   }
-  Int_t *n_of_electrons = new Int_t [nrows]; // electron counter for each row
-  TVector **tracks = new TVector* [nrows]; //pointers to the track vectors
+
 
   //--------------------------------------------------------------------
   //  Loop over tracks, the "track" contains the full history
@@ -1812,63 +2034,70 @@ void AliTPC::MakeSector(Int_t isec,Int_t nrows,TTree *TH,
   previousTrack = -1; // nothing to store so far!
 
   for(Int_t track=0;track<ntracks;track++){
-
+    Bool_t isInSector=kTRUE;
     ResetHits();
+    isInSector = TrackInVolume(isec,track);
+    if (!isInSector) continue;
+    //MI change
+    branch->GetEntry(track); // get next track
 
-    TH->GetEvent(track); // get next track
-    Int_t nhits = fHits->GetEntriesFast(); // get number of hits for this track
+    //M.I. changes
 
-    if(nhits == 0) continue; // no hits in the TPC for this track
+    tpcHit = (AliTPChit*)FirstHit(-1);
 
     //--------------------------------------------------------------
     //  Loop over hits
     //--------------------------------------------------------------
 
-    for(Int_t hit=0;hit<nhits;hit++){
 
-      tpcHit = (AliTPChit*)fHits->UncheckedAt(hit); // get a pointer to a hit
+    while(tpcHit){
       
       Int_t sector=tpcHit->fSector; // sector number
-      if(sector != isec) continue; 
+      if(sector != isec){
+       tpcHit = (AliTPChit*) NextHit();
+       continue; 
+      }
+
+       currentTrack = tpcHit->Track(); // track number
+
 
-       currentTrack = tpcHit->fTrack; // track number
         if(currentTrack != previousTrack){
                           
            // store already filled fTrack
               
-          for(i=0;i<nrows;i++){
+          for(i=0;i<nrows+2;i++){
              if(previousTrack != -1){
-              if(n_of_electrons[i]>0){
-                TVector &v = *tracks[i];
+              if(nofElectrons[i]>0){
+                 AliTPCFastVector &v = *tracks[i];
                 v(0) = previousTrack;
-                 tracks[i]->ResizeTo(4*n_of_electrons[i]+1); // shrink if necessary
+                 tracks[i]->ResizeTo(4*nofElectrons[i]+1); // shrink if necessary
                 row[i]->Add(tracks[i]);                     
               }
                else{
-                 delete tracks[i]; // delete empty TVector
+                 delete tracks[i]; // delete empty AliTPCFastVector
                  tracks[i]=0;
               }
             }
 
-             n_of_electrons[i]=0;
-             tracks[i] = new TVector(481); // TVectors for the next fTrack
+             nofElectrons[i]=0;
+             tracks[i] = new AliTPCFastVector(481); // AliTPCFastVectors for the next fTrack
 
           } // end of loop over rows
               
            previousTrack=currentTrack; // update track label 
        }
           
-       Int_t QI = (Int_t) (tpcHit->fQ); // energy loss (number of electrons)
+       Int_t qI = (Int_t) (tpcHit->fQ); // energy loss (number of electrons)
 
        //---------------------------------------------------
        //  Calculate the electron attachment probability
        //---------------------------------------------------
 
 
-        Float_t time = 1.e6*(fTPCParam->GetZLength()-TMath::Abs(tpcHit->fZ))
+        Float_t time = 1.e6*(fTPCParam->GetZLength()-TMath::Abs(tpcHit->Z()))
                                                         /fTPCParam->GetDriftV(); 
        // in microseconds!     
-       Float_t AttProb = fTPCParam->GetAttCoef()*
+       Float_t attProb = fTPCParam->GetAttCoef()*
          fTPCParam->GetOxyCont()*time; //  fraction! 
    
        //-----------------------------------------------
@@ -1876,42 +2105,62 @@ void AliTPC::MakeSector(Int_t isec,Int_t nrows,TTree *TH,
        //-----------------------------------------------
        Int_t index[3];
        index[1]=isec;
-        for(Int_t nel=0;nel<QI;nel++){
+        for(Int_t nel=0;nel<qI;nel++){
           // skip if electron lost due to the attachment
-          if((gRandom->Rndm(0)) < AttProb) continue; // electron lost!
-         xyz[0]=tpcHit->fX;
-         xyz[1]=tpcHit->fY;
-         xyz[2]=tpcHit->fZ;      
-         xyz[3]= (Float_t) (-gasgain*TMath::Log(gRandom->Rndm()));
+          if((gRandom->Rndm(0)) < attProb) continue; // electron lost!
+         xyz[0]=tpcHit->X();
+         xyz[1]=tpcHit->Y();
+         xyz[2]=tpcHit->Z();   
+         //
+         // protection for the nonphysical avalanche size (10**6 maximum)
+         //  
+          Double_t rn=TMath::Max(gRandom->Rndm(0),1.93e-22);
+         xyz[3]= (Float_t) (-gasgain*TMath::Log(rn)); 
          index[0]=1;
          
-         TransportElectron(xyz,index); //MI change -august       
-         Int_t row_number;
-         fTPCParam->GetPadRow(xyz,index); //MI change august
-         row_number = index[2];
+         TransportElectron(xyz,index);    
+         Int_t rowNumber;
+         fTPCParam->GetPadRow(xyz,index); 
+         // row 0 - cross talk from the innermost row
+         // row fNRow+1 cross talk from the outermost row
+         rowNumber = index[2]+1; 
          //transform position to local digit coordinates
          //relative to nearest pad row 
-         if ((row_number<0)||row_number>=fTPCParam->GetNRow(isec)) continue;     
-         n_of_electrons[row_number]++;   
+         if ((rowNumber<0)||rowNumber>fTPCParam->GetNRow(isec)+1) continue;
+          Float_t x1,y1;
+         if (isec <fTPCParam->GetNInnerSector()) {
+           x1 = xyz[1]*fTPCParam->GetInnerPadPitchWidth();
+           y1 = fTPCParam->GetYInner(rowNumber);
+         }
+         else{
+           x1=xyz[1]*fTPCParam->GetOuterPadPitchWidth();
+           y1 = fTPCParam->GetYOuter(rowNumber);
+         }
+         // gain inefficiency at the wires edges - linear
+         x1=TMath::Abs(x1);
+         y1-=1.;
+          if(x1>y1) xyz[3]*=TMath::Max(1.e-6,(y1-x1+1.));      
+       
+         nofElectrons[rowNumber]++;      
          //----------------------------------
          // Expand vector if necessary
          //----------------------------------
-         if(n_of_electrons[row_number]>120){
-           Int_t range = tracks[row_number]->GetNrows();
-           if((n_of_electrons[row_number])>(range-1)/4){
+         if(nofElectrons[rowNumber]>120){
+           Int_t range = tracks[rowNumber]->GetNrows();
+           if((nofElectrons[rowNumber])>(range-1)/4){
         
-             tracks[row_number]->ResizeTo(range+400); // Add 100 electrons
+             tracks[rowNumber]->ResizeTo(range+400); // Add 100 electrons
            }
          }
          
-         TVector &v = *tracks[row_number];
-         Int_t idx = 4*n_of_electrons[row_number]-3;
-
-         v(idx)=  xyz[0];   // X - pad row coordinate
-         v(idx+1)=xyz[1];   // Y - pad coordinate (along the pad-row)
-          v(idx+2)=xyz[2];   // Z - time bin coordinate
-         v(idx+3)=xyz[3];   // avalanche size  
+          AliTPCFastVector &v = *tracks[rowNumber];
+         Int_t idx = 4*nofElectrons[rowNumber]-3;
+         Real_t * position = &(((AliTPCFastVector&)v).UncheckedAt(idx)); //make code faster
+         memcpy(position,xyz,4*sizeof(Float_t));
        } // end of loop over electrons
+
+        tpcHit = (AliTPChit*)NextHit();
         
       } // end of loop over hits
     } // end of loop over tracks
@@ -1920,11 +2169,11 @@ void AliTPC::MakeSector(Int_t isec,Int_t nrows,TTree *TH,
     //   store remaining track (the last one) if not empty
     //
 
-     for(i=0;i<nrows;i++){
-       if(n_of_electrons[i]>0){
-          TVector &v = *tracks[i];
+     for(i=0;i<nrows+2;i++){
+       if(nofElectrons[i]>0){
+          AliTPCFastVector &v = *tracks[i];
          v(0) = previousTrack;
-          tracks[i]->ResizeTo(4*n_of_electrons[i]+1); // shrink if necessary
+          tracks[i]->ResizeTo(4*nofElectrons[i]+1); // shrink if necessary
          row[i]->Add(tracks[i]);  
        }
        else{
@@ -1934,7 +2183,7 @@ void AliTPC::MakeSector(Int_t isec,Int_t nrows,TTree *TH,
       }  
 
           delete [] tracks;
-          delete [] n_of_electrons;
+          delete [] nofElectrons;
  
 
 } // end of MakeSector
@@ -1948,14 +2197,16 @@ void AliTPC::Init()
   //
   Int_t i;
   //
-  printf("\n");
-  for(i=0;i<35;i++) printf("*");
-  printf(" TPC_INIT ");
-  for(i=0;i<35;i++) printf("*");
-  printf("\n");
-  //
-  for(i=0;i<80;i++) printf("*");
-  printf("\n");
+  if(fDebug) {
+    printf("\n%s: ",ClassName());
+    for(i=0;i<35;i++) printf("*");
+    printf(" TPC_INIT ");
+    for(i=0;i<35;i++) printf("*");
+    printf("\n%s: ",ClassName());
+    //
+    for(i=0;i<80;i++) printf("*");
+    printf("\n");
+  }
 }
 
 //_____________________________________________________________________________
@@ -1964,25 +2215,25 @@ void AliTPC::MakeBranch(Option_t* option)
   //
   // Create Tree branches for the TPC.
   //
+  if(GetDebug()) Info("MakeBranch","");
   Int_t buffersize = 4000;
   char branchname[10];
   sprintf(branchname,"%s",GetName());
+  
+  const char *h = strstr(option,"H");
 
+  if ( h && (fHitType<=1) && (fHits == 0x0)) fHits = new TClonesArray("AliTPChit", 176);//skowron 20.06.03
+  
   AliDetector::MakeBranch(option);
 
-  char *D = strstr(option,"D");
-
-  if (fDigits   && gAlice->TreeD() && D) {
-    gAlice->TreeD()->Branch(branchname,&fDigits, buffersize);
-    printf("Making Branch %s for digits\n",branchname);
-  }    
-
-  char *R = strstr(option,"R");
+  const char *d = strstr(option,"D");
+  if (fDigits   && fLoader->TreeD() && d) 
+   {
+      MakeBranchInTree(gAlice->TreeD(), branchname, &fDigits, buffersize, 0);
+   }   
 
-  if (fClusters && gAlice->TreeR() && R) {
-    gAlice->TreeR()->Branch(branchname,&fClusters, buffersize);
-    printf("Making Branch %s for Clusters\n",branchname);
-  }    
+  if (fHitType>1) MakeBranch2(option,0); // MI change 14.09.2000
 }
  
 //_____________________________________________________________________________
@@ -1990,12 +2241,9 @@ void AliTPC::ResetDigits()
 {
   //
   // Reset number of digits and the digits array for this detector
-  // reset clusters
   //
   fNdigits   = 0;
   if (fDigits)   fDigits->Clear();
-  fNclusters = 0;
-  if (fClusters) fClusters->Clear();
 }
 
 //_____________________________________________________________________________
@@ -2008,7 +2256,6 @@ void AliTPC::SetSecAL(Int_t sec)
   //-----------------------------------------------------------------
   // Origin: Marek Kowalski  IFJ, Krakow, Marek.Kowalski@ifj.edu.pl
   //-----------------------------------------------------------------
-
   fSecAL = sec;
 }
 
@@ -2022,7 +2269,6 @@ void AliTPC::SetSecAU(Int_t sec)
   //-----------------------------------------------------------------
   // Origin: Marek Kowalski  IFJ, Krakow, Marek.Kowalski@ifj.edu.pl
   //-----------------------------------------------------------------
-
   fSecAU = sec;
 }
 
@@ -2087,9 +2333,12 @@ void AliTPC::SetSens(Int_t sens)
 
   fSens = sens;
 }
+
  
-void AliTPC::SetSide(Float_t side)
+void AliTPC::SetSide(Float_t side=0.)
 {
+  // choice of the TPC side
+
   fSide = side;
  
 }
@@ -2098,6 +2347,8 @@ void AliTPC::SetGasMixt(Int_t nc,Int_t c1,Int_t c2,Int_t c3,Float_t p1,
                            Float_t p2,Float_t p3)
 {
 
+  // gax mixture definition
+
  fNoComp = nc;
  
  fMixtComp[0]=c1;
@@ -2129,103 +2380,21 @@ void AliTPC::TransportElectron(Float_t *xyz, Int_t *index)
   Float_t driftl=xyz[2];
   if(driftl<0.01) driftl=0.01;
   driftl=TMath::Sqrt(driftl);
-  Float_t sig_t = driftl*(fTPCParam->GetDiffT());
-  Float_t sig_l = driftl*(fTPCParam->GetDiffL());
-  xyz[0]=gRandom->Gaus(xyz[0],sig_t);
-  xyz[1]=gRandom->Gaus(xyz[1],sig_t);
-  xyz[2]=gRandom->Gaus(xyz[2],sig_l);
+  Float_t sigT = driftl*(fTPCParam->GetDiffT());
+  Float_t sigL = driftl*(fTPCParam->GetDiffL());
+  xyz[0]=gRandom->Gaus(xyz[0],sigT);
+  xyz[1]=gRandom->Gaus(xyz[1],sigT);
+  xyz[2]=gRandom->Gaus(xyz[2],sigL);
 
   // ExB
   
   if (fTPCParam->GetMWPCReadout()==kTRUE){
-    Float_t x1=xyz[0];
-    fTPCParam->Transform2to2NearestWire(xyz,index);
-    Float_t dx=xyz[0]-x1;
+    Float_t dx = fTPCParam->Transform2to2NearestWire(xyz,index);
     xyz[1]+=dx*(fTPCParam->GetOmegaTau());
   }
-  //add nonisochronity (not implemented yet)
-  
-}
-//_____________________________________________________________________________
-void AliTPC::Streamer(TBuffer &R__b)
-{
-  //
-  // Stream an object of class AliTPC.
-  //
-   if (R__b.IsReading()) {
-      Version_t R__v = R__b.ReadVersion(); if (R__v) { }
-      AliDetector::Streamer(R__b);
-      if (R__v < 2) return;
-      R__b >> fNsectors;
-      R__b >> fNclusters;
-      R__b >> fNtracks;
-
-   } else {
-      R__b.WriteVersion(AliTPC::IsA());
-      AliDetector::Streamer(R__b);
-      R__b << fNsectors;
-      R__b << fNclusters;
-      R__b << fNtracks;
-   }
+  //add nonisochronity (not implemented yet)  
 }
   
-ClassImp(AliTPCcluster)
-//_____________________________________________________________________________
-AliTPCcluster::AliTPCcluster(Float_t *hits, Int_t *lab)
-{
-  //
-  // Creates a simulated cluster for the TPC
-  //
-  fTracks[0]  = lab[0];
-  fTracks[1]  = lab[1];
-  fTracks[2]  = lab[2];
-  fSector     = lab[3];
-  fPadRow     = lab[4];
-  fY          = hits[0];
-  fZ          = hits[1];
-  fQ          = hits[2];
-  fSigmaY2    = hits[3];
-  fSigmaZ2    = hits[4];
-}
-//_____________________________________________________________________________
-void AliTPCcluster::GetXYZ(Float_t *x, const AliTPCParam *par) const 
-{
-  //
-  // Transformation from local to global coordinate system
-  //
-  x[0]=par->GetPadRowRadii(fSector,fPadRow);
-  x[1]=fY;
-  x[2]=fZ;
-  Float_t cs, sn, tmp;
-  par->AdjustCosSin(fSector,cs,sn);
-  tmp = x[0]*cs-x[1]*sn;
-  x[1]= x[0]*sn+x[1]*cs; x[0]=tmp;
-}
-//_____________________________________________________________________________
-Int_t AliTPCcluster::Compare(TObject * o)
-{
-  //
-  // compare two clusters according y coordinata
-  //
-  AliTPCcluster *cl= (AliTPCcluster *)o;
-  if (fY<cl->fY) return -1;
-  if (fY==cl->fY) return 0;
-  return 1;  
-}
-
-Bool_t AliTPCcluster::IsSortable() const
-{
-  //
-  //make AliTPCcluster sortabale
-  //
-  return kTRUE; 
-}
-
-
-
 ClassImp(AliTPCdigit)
  
 //_____________________________________________________________________________
@@ -2260,421 +2429,660 @@ AliHit(shunt,track)
   fQ          = hits[3];
 }
  
-ClassImp(AliTPCtrack)
-//_____________________________________________________________________________
-AliTPCtrack::AliTPCtrack(Float_t *hits)
+//________________________________________________________________________
+// Additional code because of the AliTPCTrackHitsV2
+
+void AliTPC::MakeBranch2(Option_t *option,const char */*file*/)
 {
   //
-  // Default creator for a TPC reconstructed track object
-  //
-  fX=hits[0]; // This is dummy code !
+  // Create a new branch in the current Root Tree
+  // The branch of fHits is automatically split
+  // MI change 14.09.2000
+  if(GetDebug()) Info("MakeBranch2","");
+  if (fHitType<2) return;
+  char branchname[10];
+  sprintf(branchname,"%s2",GetName());  
+  //
+  // Get the pointer to the header
+  const char *cH = strstr(option,"H");
+  //
+  if (fTrackHits   && TreeH() && cH && fHitType&4) 
+   {
+    if(GetDebug()) Info("MakeBranch2","Making branch for Type 4 Hits");
+    TreeH()->Branch(branchname,"AliTPCTrackHitsV2",&fTrackHits,fBufferSize,99);
+   }   
+
+  if (fTrackHitsOld   && TreeH() && cH && fHitType&2) 
+   {    
+    if(GetDebug()) Info("MakeBranch2","Making branch for Type 2 Hits");
+    AliObjectBranch * branch = new AliObjectBranch(branchname,"AliTPCTrackHits",&fTrackHitsOld, 
+                                                   TreeH(),fBufferSize,99);
+    TreeH()->GetListOfBranches()->Add(branch);
+   }   
 }
-//_________________________________________________________________________
 
-AliTPCtrack::AliTPCtrack(const AliTPCcluster *c,const TVector& xx,
-                        const TMatrix& CC, Double_t xref, Double_t alpha):
-  x(xx),C(CC),fClusters(200)
+void AliTPC::SetTreeAddress()
+{
+//Sets tree address for hits  
+  if (fHitType<=1)
+   {
+     if (fHits == 0x0 ) fHits = new TClonesArray("AliTPChit", 176);//skowron 20.06.03
+     AliDetector::SetTreeAddress();
+   }
+  if (fHitType>1) SetTreeAddress2();
+}
+
+void AliTPC::SetTreeAddress2()
 {
-  //-----------------------------------------------------------------
-  // This is the main track constructor.
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  fX=xref;
-  fAlpha=alpha;
-  fChi2=0.;
-  fClusters.AddLast((AliTPCcluster*)(c));
+  // Set branch address for the TrackHits Tree
+  // 
+  if(GetDebug()) Info("SetTreeAddress2","");
+  
+  TBranch *branch;
+  char branchname[20];
+  sprintf(branchname,"%s2",GetName());
+  //
+  // Branch address for hit tree
+  TTree *treeH = TreeH();
+  if ((treeH)&&(fHitType&4)) {
+    branch = treeH->GetBranch(branchname);
+    if (branch) 
+     {
+       branch->SetAddress(&fTrackHits);
+       if (GetDebug()) Info("SetTreeAddress2","fHitType&4 Setting");
+     }
+    else 
+    if (GetDebug()) Info("SetTreeAddress2","fHitType&4 Failed (can not find branch)");
+    
+  }
+  if ((treeH)&&(fHitType&2)) {
+    branch = treeH->GetBranch(branchname);
+    if (branch) 
+     {
+       branch->SetAddress(&fTrackHitsOld);
+       if (GetDebug()) Info("SetTreeAddress2","fHitType&2 Setting");
+     }
+    else if (GetDebug()) 
+      Info("SetTreeAddress2","fHitType&2 Failed (can not find branch)");
+  }
+  //set address to TREETR
+
+  TTree *treeTR = TreeTR();
+  if (treeTR && fTrackReferences) {
+    branch = treeTR->GetBranch(GetName());
+    if (branch) branch->SetAddress(&fTrackReferences);
+  }
+
 }
 
-//_____________________________________________________________________________
-AliTPCtrack::AliTPCtrack(const AliTPCtrack& t) : x(t.x), C(t.C),
-  fClusters(t.fClusters.GetEntriesFast()) 
+void AliTPC::FinishPrimary()
 {
-  //-----------------------------------------------------------------
-  // This is a track copy constructor.
+  if (fTrackHits &&fHitType&4)      fTrackHits->FlushHitStack();  
+  if (fTrackHitsOld && fHitType&2)  fTrackHitsOld->FlushHitStack();  
+}
+
+
+void AliTPC::AddHit2(Int_t track, Int_t *vol, Float_t *hits)
+{ 
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  fX=t.fX;
-  fChi2=t.fChi2;
-  fAlpha=t.fAlpha;
-  Int_t n=t.fClusters.GetEntriesFast();
-  for (Int_t i=0; i<n; i++) fClusters.AddLast(t.fClusters.UncheckedAt(i));
+  // add hit to the list  
+  Int_t rtrack;
+  if (fIshunt) {
+    int primary = gAlice->GetPrimary(track);
+    gAlice->Particle(primary)->SetBit(kKeepBit);
+    rtrack=primary;
+  } else {
+    rtrack=track;
+    gAlice->FlagTrack(track);
+  }  
+  //AliTPChit *hit = (AliTPChit*)fHits->UncheckedAt(fNhits-1);
+  //if (hit->fTrack!=rtrack)
+  //  cout<<"bad track number\n";
+  if (fTrackHits && fHitType&4) 
+    fTrackHits->AddHitKartez(vol[0],rtrack, hits[0],
+                             hits[1],hits[2],(Int_t)hits[3]);
+  if (fTrackHitsOld &&fHitType&2 ) 
+    fTrackHitsOld->AddHitKartez(vol[0],rtrack, hits[0],
+                                hits[1],hits[2],(Int_t)hits[3]);
+  
 }
 
-//_____________________________________________________________________________
-Int_t AliTPCtrack::Compare(TObject *o) {
-  //-----------------------------------------------------------------
-  // This function compares tracks according to the uncertainty of their
-  // position in Y.
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  AliTPCtrack *t=(AliTPCtrack*)o;
-  Double_t co=t->GetSigmaY2();
-  Double_t c =GetSigmaY2();
-  if (c>co) return 1;
-  else if (c<co) return -1;
-  return 0;
+void AliTPC::ResetHits()
+{ 
+  if (fHitType&1) AliDetector::ResetHits();
+  if (fHitType>1) ResetHits2();
 }
 
-//_____________________________________________________________________________
-Int_t AliTPCtrack::PropagateTo(Double_t xk,Double_t x0,Double_t rho,Double_t pm)
+void AliTPC::ResetHits2()
 {
-  //-----------------------------------------------------------------
-  // This function propagates a track to a reference plane x=xk.
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  if (TMath::Abs(x(2)*xk - x(3)) >= 0.999) {
-    if (*this>4) cerr<<*this<<" AliTPCtrack warning: Propagation failed !\n";
-    return 0;
-  }
+  //reset hits
+  if (fTrackHits && fHitType&4) fTrackHits->Clear();
+  if (fTrackHitsOld && fHitType&2) fTrackHitsOld->Clear();
 
-  Double_t x1=fX, x2=x1+(xk-x1), dx=x2-x1, y1=x(0), z1=x(1);
-  Double_t c1=x(2)*x1 - x(3), r1=sqrt(1.- c1*c1);
-  Double_t c2=x(2)*x2 - x(3), r2=sqrt(1.- c2*c2);
-  
-  x(0) += dx*(c1+c2)/(r1+r2);
-  x(1) += dx*(c1+c2)/(c1*r2 + c2*r1)*x(4);
-
-  TMatrix F(5,5); F.UnitMatrix();
-  Double_t rr=r1+r2, cc=c1+c2, xx=x1+x2;
-  F(0,2)= dx*(rr*xx + cc*(c1*x1/r1+c2*x2/r2))/(rr*rr);
-  F(0,3)=-dx*(2*rr + cc*(c1/r1 + c2/r2))/(rr*rr);
-  Double_t cr=c1*r2+c2*r1;
-  F(1,2)= dx*x(4)*(cr*xx-cc*(r1*x2-c2*c1*x1/r1+r2*x1-c1*c2*x2/r2))/(cr*cr);
-  F(1,3)=-dx*x(4)*(2*cr + cc*(c2*c1/r1-r1 + c1*c2/r2-r2))/(cr*cr);
-  F(1,4)= dx*cc/cr; 
-  TMatrix tmp(F,TMatrix::kMult,C);
-  C.Mult(tmp,TMatrix(TMatrix::kTransposed,F));
-
-  fX=x2;
-
-  //Multiple scattering******************
-  Double_t ey=x(2)*fX - x(3);
-  Double_t ex=sqrt(1-ey*ey);
-  Double_t ez=x(4);
-  TMatrix Q(5,5); Q=0.;
-  Q(2,2)=ez*ez+ey*ey;   Q(2,3)=-ex*ey;       Q(2,4)=-ex*ez;
-  Q(3,2)=Q(2,3);        Q(3,3)= ez*ez+ex*ex; Q(3,4)=-ey*ez;
-  Q(4,2)=Q(2,4);        Q(4,3)= Q(3,4);      Q(4,4)=1.;
-  
-  F=0;
-  F(2,2)=-x(2)*ex;          F(2,3)=-x(2)*ey;
-  F(3,2)=-ex*(x(2)*fX-ey);  F(3,3)=-(1.+ x(2)*fX*ey - ey*ey);
-  F(4,2)=-ez*ex;            F(4,3)=-ez*ey;           F(4,4)=1.;
-  
-  tmp.Mult(F,Q);
-  Q.Mult(tmp,TMatrix(TMatrix::kTransposed,F));
+}   
+
+AliHit* AliTPC::FirstHit(Int_t track)
+{
+  if (fHitType>1) return FirstHit2(track);
+  return AliDetector::FirstHit(track);
+}
+AliHit* AliTPC::NextHit()
+{
+  if (fHitType>1) return NextHit2();
   
-  Double_t p2=GetPt()*GetPt()*(1.+x(4)*x(4));
-  Double_t beta2=p2/(p2 + pm*pm);
-  Double_t d=sqrt((x1-fX)*(x1-fX)+(y1-x(0))*(y1-x(0))+(z1-x(1))*(z1-x(1)));
-  Double_t theta2=14.1*14.1/(beta2*p2*1e6)*d/x0*rho;
-  Q*=theta2;
-  C+=Q;
-
-  //Energy losses************************
-  Double_t dE=0.153e-3/beta2*(log(5940*beta2/(1-beta2)) - beta2)*d*rho;
-  if (x1 < x2) dE=-dE;
-  x(2)*=(1.- sqrt(p2+pm*pm)/p2*dE);
-  //x(3)*=(1.- sqrt(p2+pm*pm)/p2*dE);
-
-  return 1;
+  return AliDetector::NextHit();
 }
 
-//_____________________________________________________________________________
-void AliTPCtrack::PropagateToVertex(Double_t x0,Double_t rho,Double_t pm) 
+AliHit* AliTPC::FirstHit2(Int_t track)
 {
-  //-----------------------------------------------------------------
-  // This function propagates tracks to the "vertex".
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  Double_t c=x(2)*fX - x(3);
-  Double_t tgf=-x(3)/(x(2)*x(0) + sqrt(1-c*c));
-  Double_t snf=tgf/sqrt(1.+ tgf*tgf);
-  Double_t xv=(x(3)+snf)/x(2);
-  PropagateTo(xv,x0,rho,pm);
+  // Initialise the hit iterator
+  // Return the address of the first hit for track
+  // If track>=0 the track is read from disk
+  // while if track<0 the first hit of the current
+  // track is returned
+  // 
+  if(track>=0) {
+    gAlice->ResetHits();
+    TreeH()->GetEvent(track);
+  }
+  //
+  if (fTrackHits && fHitType&4) {
+    fTrackHits->First();
+    return fTrackHits->GetHit();
+  }
+  if (fTrackHitsOld && fHitType&2) {
+    fTrackHitsOld->First();
+    return fTrackHitsOld->GetHit();
+  }
+
+  else return 0;
 }
 
-//_____________________________________________________________________________
-void AliTPCtrack::Update(const AliTPCcluster *c, Double_t chisq)
+AliHit* AliTPC::NextHit2()
 {
-  //-----------------------------------------------------------------
-  // This function associates a clusters with this track.
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  TMatrix H(2,5); H.UnitMatrix();
-  TMatrix Ht(TMatrix::kTransposed,H);
-  TVector m(2);   m(0)=c->fY; m(1)=c->fZ; 
-  TMatrix V(2,2); V(0,0)=c->fSigmaY2; V(0,1)=0.; V(1,0)=0.; V(1,1)=c->fSigmaZ2;
+  //Return the next hit for the current track
 
-  TMatrix tmp(H,TMatrix::kMult,C);
-  TMatrix R(tmp,TMatrix::kMult,Ht); R+=V;
-  
-  Double_t det=(Double_t)R(0,0)*R(1,1) - (Double_t)R(0,1)*R(1,0);
-  R(0,1)=R(0,0); R(0,0)=R(1,1); R(1,1)=R(0,1); 
-  R(1,0)*=-1; R(0,1)=R(1,0);
-  R*=1./det;
-  
-  //R.Invert();
-  
-  TMatrix K(C,TMatrix::kMult,Ht); K*=R;
-  
-  TVector savex=x;
-  x*=H; x-=m;
 
-  x*=-1; x*=K; x+=savex;
-  if (TMath::Abs(x(2)*fX-x(3)) >= 0.999) {
-    if (*this>4) cerr<<*this<<" AliTPCtrack warning: Filtering failed !\n";
-    x=savex;
-    return;
+  if (fTrackHitsOld && fHitType&2) {
+    fTrackHitsOld->Next();
+    return fTrackHitsOld->GetHit();
   }
-  
-  TMatrix saveC=C;
-  C.Mult(K,tmp); C-=saveC; C*=-1;
-
-  fClusters.AddLast((AliTPCcluster*)c);
-  fChi2 += chisq;
+  if (fTrackHits) {
+    fTrackHits->Next();
+    return fTrackHits->GetHit();
+  }
+  else 
+    return 0;
 }
 
-//_____________________________________________________________________________
-Int_t AliTPCtrack::Rotate(Double_t alpha)
+void AliTPC::LoadPoints(Int_t)
 {
-  //-----------------------------------------------------------------
-  // This function rotates this track.
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  fAlpha += alpha;
-  
-  Double_t x1=fX, y1=x(0);
-  Double_t ca=cos(alpha), sa=sin(alpha);
-  Double_t r1=x(2)*fX - x(3);
-  
-  fX = x1*ca + y1*sa;
-  x(0)=-x1*sa + y1*ca;
-  x(3)=x(3)*ca + (x(2)*y1 + sqrt(1.- r1*r1))*sa;
+  Int_t a = 0;
+  /*  if(fHitType==1) return AliDetector::LoadPoints(a);
+  LoadPoints2(a);
+  */
+  if(fHitType==1) AliDetector::LoadPoints(a);
+  else LoadPoints2(a);
+   
+  // LoadPoints3(a);
+
+}
+
+
+void AliTPC::RemapTrackHitIDs(Int_t *map)
+{
+  if (!fTrackHits) return;
   
-  Double_t r2=x(2)*fX - x(3);
-  if (TMath::Abs(r2) >= 0.999) {
-    if (*this>4) cerr<<*this<<" AliTPCtrack warning: Rotation failed !\n";
-    return 0;
+  if (fTrackHitsOld && fHitType&2){
+    AliObjectArray * arr = fTrackHitsOld->fTrackHitsInfo;
+    for (UInt_t i=0;i<arr->GetSize();i++){
+      AliTrackHitsInfo * info = (AliTrackHitsInfo *)(arr->At(i));
+      info->fTrackID = map[info->fTrackID];
+    }
   }
-  
-  Double_t y0=x(0) + sqrt(1.- r2*r2)/x(2);
-  if ((x(0)-y0)*x(2) >= 0.) {
-    if (*this>4) cerr<<*this<<" AliTPCtrack warning: Rotation failed !!!\n";
-    return 0;
+  if (fTrackHitsOld && fHitType&4){
+    TClonesArray * arr = fTrackHits->GetArray();;
+    for (Int_t i=0;i<arr->GetEntriesFast();i++){
+      AliTrackHitsParamV2 * info = (AliTrackHitsParamV2 *)(arr->At(i));
+      info->fTrackID = map[info->fTrackID];
+    }
   }
-  
-  TMatrix F(5,5); F.UnitMatrix();
-  F(0,0)=ca;
-  F(3,0)=x(2)*sa; 
-  F(3,2)=(y1 - r1*x1/sqrt(1.- r1*r1))*sa; 
-  F(3,3)= ca + sa*r1/sqrt(1.- r1*r1);
-  TMatrix tmp(F,TMatrix::kMult,C); 
-  // Double_t dy2=C(0,0);
-  C.Mult(tmp,TMatrix(TMatrix::kTransposed,F));
-  // C(0,0)+=dy2*sa*sa*r1*r1/(1.- r1*r1);
-  // C(1,1)+=dy2*sa*sa*x(4)*x(4)/(1.- r1*r1);
-  
-  return 1;
 }
 
-//_____________________________________________________________________________
-void AliTPCtrack::UseClusters() const 
+Bool_t   AliTPC::TrackInVolume(Int_t id,Int_t track)
 {
-  //-----------------------------------------------------------------
-  // This function marks clusters associated with this track.
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  Int_t num_of_clusters=fClusters.GetEntriesFast();
-  for (Int_t i=0; i<num_of_clusters; i++) {
-    //if (i<=14) continue;
-    AliTPCcluster *c=(AliTPCcluster*)fClusters.UncheckedAt(i);
-    c->Use();   
+  //return bool information - is track in given volume
+  //load only part of the track information 
+  //return true if current track is in volume
+  //
+  //  return kTRUE;
+  if (fTrackHitsOld && fHitType&2) {
+    TBranch * br = TreeH()->GetBranch("fTrackHitsInfo");
+    br->GetEvent(track);
+    AliObjectArray * ar = fTrackHitsOld->fTrackHitsInfo;
+    for (UInt_t j=0;j<ar->GetSize();j++){
+      if (  ((AliTrackHitsInfo*)ar->At(j))->fVolumeID==id) return kTRUE;
+    } 
+  }
+
+  if (fTrackHits && fHitType&4) {
+    TBranch * br1 = TreeH()->GetBranch("fVolumes");
+    TBranch * br2 = TreeH()->GetBranch("fNVolumes");    
+    br2->GetEvent(track);
+    br1->GetEvent(track);    
+    Int_t *volumes = fTrackHits->GetVolumes();
+    Int_t nvolumes = fTrackHits->GetNVolumes();
+    if (!volumes && nvolumes>0) {
+      printf("Problematic track\t%d\t%d",track,nvolumes);
+      return kFALSE;
+    }
+    for (Int_t j=0;j<nvolumes; j++)
+      if (volumes[j]==id) return kTRUE;    
+  }
+
+  if (fHitType&1) {
+    TBranch * br = TreeH()->GetBranch("fSector");
+    br->GetEvent(track);
+    for (Int_t j=0;j<fHits->GetEntriesFast();j++){
+      if (  ((AliTPChit*)fHits->At(j))->fSector==id) return kTRUE;
+    } 
   }
+  return kFALSE;  
+
 }
 
 //_____________________________________________________________________________
-Double_t AliTPCtrack::GetPredictedChi2(const AliTPCcluster *c) const 
+void AliTPC::LoadPoints2(Int_t)
 {
-  //-----------------------------------------------------------------
-  // This function calculates a predicted chi2 increment.
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  TMatrix H(2,5); H.UnitMatrix();
-  TVector m(2);   m(0)=c->fY; m(1)=c->fZ; 
-  TMatrix V(2,2); V(0,0)=c->fSigmaY2; V(0,1)=0.; V(1,0)=0.; V(1,1)=c->fSigmaZ2;
-  TVector res=x;  res*=H; res-=m; //res*=-1; 
-  TMatrix tmp(H,TMatrix::kMult,C);
-  TMatrix R(tmp,TMatrix::kMult,TMatrix(TMatrix::kTransposed,H)); R+=V;
+  // Store x, y, z of all hits in memory
+  //
+  if (fTrackHits == 0 && fTrackHitsOld==0) return;
+  //
+  Int_t nhits =0;
+  if (fHitType&4) nhits = fTrackHits->GetEntriesFast();
+  if (fHitType&2) nhits = fTrackHitsOld->GetEntriesFast();
   
-  Double_t det=(Double_t)R(0,0)*R(1,1) - (Double_t)R(0,1)*R(1,0);
-  if (TMath::Abs(det) < 1.e-10) {
-    if (*this>4) cerr<<*this<<" AliTPCtrack warning: Singular matrix !\n";
-    return 1e10;
+  if (nhits == 0) return;
+  Int_t tracks = gAlice->GetNtrack();
+  if (fPoints == 0) fPoints = new TObjArray(tracks);
+  AliHit *ahit;
+  //
+  Int_t *ntrk=new Int_t[tracks];
+  Int_t *limi=new Int_t[tracks];
+  Float_t **coor=new Float_t*[tracks];
+  for(Int_t i=0;i<tracks;i++) {
+    ntrk[i]=0;
+    coor[i]=0;
+    limi[i]=0;
   }
-  R(0,1)=R(0,0); R(0,0)=R(1,1); R(1,1)=R(0,1); 
-  R(1,0)*=-1; R(0,1)=R(1,0);
-  R*=1./det;
-  
-  //R.Invert();
-  
-  TVector r=res;
-  res*=R;
-  return r*res;
+  //
+  AliPoints *points = 0;
+  Float_t *fp=0;
+  Int_t trk;
+  Int_t chunk=nhits/4+1;
+  //
+  // Loop over all the hits and store their position
+  //
+  ahit = FirstHit2(-1);
+  while (ahit){
+    trk=ahit->GetTrack();
+    if(ntrk[trk]==limi[trk]) {
+      //
+      // Initialise a new track
+      fp=new Float_t[3*(limi[trk]+chunk)];
+      if(coor[trk]) {
+       memcpy(fp,coor[trk],sizeof(Float_t)*3*limi[trk]);
+       delete [] coor[trk];
+      }
+      limi[trk]+=chunk;
+      coor[trk] = fp;
+    } else {
+      fp = coor[trk];
+    }
+    fp[3*ntrk[trk]  ] = ahit->X();
+    fp[3*ntrk[trk]+1] = ahit->Y();
+    fp[3*ntrk[trk]+2] = ahit->Z();
+    ntrk[trk]++;
+    ahit = NextHit2();
+  }
+
+
+
+  //
+  for(trk=0; trk<tracks; ++trk) {
+    if(ntrk[trk]) {
+      points = new AliPoints();
+      points->SetMarkerColor(GetMarkerColor());
+      points->SetMarkerSize(GetMarkerSize());
+      points->SetDetector(this);
+      points->SetParticle(trk);
+      points->SetPolyMarker(ntrk[trk],coor[trk],GetMarkerStyle());
+      fPoints->AddAt(points,trk);
+      delete [] coor[trk];
+      coor[trk]=0;
+    }
+  }
+  delete [] coor;
+  delete [] ntrk;
+  delete [] limi;
 }
 
+
 //_____________________________________________________________________________
-struct S { Int_t lab; Int_t max; };
-Int_t AliTPCtrack::GetLabel(Int_t nrows) const 
+void AliTPC::LoadPoints3(Int_t)
 {
-  //-----------------------------------------------------------------
-  // This function returns the track label. If label<0, this track is fake.
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  Int_t num_of_clusters=fClusters.GetEntriesFast();
-  S *s=new S[num_of_clusters];
-  Int_t i;
-  for (i=0; i<num_of_clusters; i++) s[i].lab=s[i].max=0;
-  
-  Int_t lab=123456789;
-  for (i=0; i<num_of_clusters; i++) {
-    AliTPCcluster *c=(AliTPCcluster*)fClusters.UncheckedAt(i);
-    lab=TMath::Abs(c->fTracks[0]);
-    Int_t j;
-    for (j=0; j<num_of_clusters; j++)
-      if (s[j].lab==lab || s[j].max==0) break;
-    s[j].lab=lab;
-    s[j].max++;
+  // Store x, y, z of all hits in memory
+  // - only intersection point with pad row
+  if (fTrackHits == 0) return;
+  //
+  Int_t nhits = fTrackHits->GetEntriesFast();
+  if (nhits == 0) return;
+  Int_t tracks = gAlice->GetNtrack();
+  if (fPoints == 0) fPoints = new TObjArray(2*tracks);
+  fPoints->Expand(2*tracks);
+  AliHit *ahit;
+  //
+  Int_t *ntrk=new Int_t[tracks];
+  Int_t *limi=new Int_t[tracks];
+  Float_t **coor=new Float_t*[tracks];
+  for(Int_t i=0;i<tracks;i++) {
+    ntrk[i]=0;
+    coor[i]=0;
+    limi[i]=0;
   }
-  
-  Int_t max=0;
-  for (i=0; i<num_of_clusters; i++) 
-    if (s[i].max>max) {max=s[i].max; lab=s[i].lab;}
-    
-  delete[] s;
-  
-  for (i=0; i<num_of_clusters; i++) {
-    AliTPCcluster *c=(AliTPCcluster*)fClusters.UncheckedAt(i);
-    if (TMath::Abs(c->fTracks[1]) == lab ||
-        TMath::Abs(c->fTracks[2]) == lab ) max++;
+  //
+  AliPoints *points = 0;
+  Float_t *fp=0;
+  Int_t trk;
+  Int_t chunk=nhits/4+1;
+  //
+  // Loop over all the hits and store their position
+  //
+  ahit = FirstHit2(-1);
+  //for (Int_t hit=0;hit<nhits;hit++) {
+
+  Int_t lastrow = -1;
+  while (ahit){
+    //    ahit = (AliHit*)fHits->UncheckedAt(hit);
+    trk=ahit->GetTrack(); 
+    Float_t  x[3]={ahit->X(),ahit->Y(),ahit->Z()};
+    Int_t    index[3]={1,((AliTPChit*)ahit)->fSector,0};
+    Int_t    currentrow = fTPCParam->GetPadRow(x,index) ;
+    if (currentrow!=lastrow){
+      lastrow = currentrow;
+      //later calculate intersection point           
+      if(ntrk[trk]==limi[trk]) {
+       //
+       // Initialise a new track
+       fp=new Float_t[3*(limi[trk]+chunk)];
+       if(coor[trk]) {
+         memcpy(fp,coor[trk],sizeof(Float_t)*3*limi[trk]);
+         delete [] coor[trk];
+       }
+       limi[trk]+=chunk;
+       coor[trk] = fp;
+      } else {
+       fp = coor[trk];
+      }
+      fp[3*ntrk[trk]  ] = ahit->X();
+      fp[3*ntrk[trk]+1] = ahit->Y();
+      fp[3*ntrk[trk]+2] = ahit->Z();
+      ntrk[trk]++;
+    }
+    ahit = NextHit2();
   }
   
-  if (1.-Float_t(max)/num_of_clusters > 0.10) return -lab;
-  
-  Int_t tail=Int_t(0.08*nrows);
-  if (num_of_clusters < tail) return lab;
-  
-  max=0;
-  for (i=1; i<=tail; i++) {
-    AliTPCcluster *c=(AliTPCcluster*)fClusters.UncheckedAt(num_of_clusters-i);
-    if (lab == TMath::Abs(c->fTracks[0]) ||
-        lab == TMath::Abs(c->fTracks[1]) ||
-        lab == TMath::Abs(c->fTracks[2])) max++;
+  //
+  for(trk=0; trk<tracks; ++trk) {
+    if(ntrk[trk]) {
+      points = new AliPoints();
+      points->SetMarkerColor(GetMarkerColor()+1);
+      points->SetMarkerStyle(5);
+      points->SetMarkerSize(0.2);
+      points->SetDetector(this);
+      points->SetParticle(trk);
+      //      points->SetPolyMarker(ntrk[trk],coor[trk],GetMarkerStyle()20);
+      points->SetPolyMarker(ntrk[trk],coor[trk],30);
+      fPoints->AddAt(points,tracks+trk);
+      delete [] coor[trk];
+      coor[trk]=0;
+    }
   }
-  if (max < Int_t(0.5*tail)) return -lab;
-  
-  return lab;
+  delete [] coor;
+  delete [] ntrk;
+  delete [] limi;
 }
 
-//_____________________________________________________________________________
-void AliTPCtrack::GetPxPyPz(Double_t& px, Double_t& py, Double_t& pz) const 
+
+
+void AliTPC::FindTrackHitsIntersection(TClonesArray * /*arr*/)
 {
-  //-----------------------------------------------------------------
-  // This function returns reconstructed track momentum in the global system.
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  Double_t pt=TMath::Abs(GetPt()); // GeV/c
-  Double_t r=x(2)*fX-x(3);
-  Double_t y0=x(0) + sqrt(1.- r*r)/x(2);
-  px=-pt*(x(0)-y0)*x(2);    //cos(phi);
-  py=-pt*(x(3)-fX*x(2));   //sin(phi);
-  pz=pt*x(4);
-  Double_t tmp=px*TMath::Cos(fAlpha) - py*TMath::Sin(fAlpha);
-  py=px*TMath::Sin(fAlpha) + py*TMath::Cos(fAlpha);
-  px=tmp;  
-}
 
-//_____________________________________________________________________________
-Double_t AliTPCtrack::GetdEdX(Double_t low, Double_t up) const {
-  //-----------------------------------------------------------------
-  // This funtion calculates dE/dX within the "low" and "up" cuts.
   //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------
-  Int_t ncl=fClusters.GetEntriesFast();
-  Int_t n=0;
-  Double_t *q=new Double_t[ncl];
-  Int_t i;
-  for (i=1; i<ncl; i++) { //Shall I think of this "i=1" ? (I.Belikov)
-     AliTPCcluster *cl=(AliTPCcluster*)(fClusters.UncheckedAt(i));
-     q[n++]=TMath::Abs(cl->fQ)/cl->fdEdX;
-     if (cl->fSector<36) q[n-1]*=1.1;
-  }
+  //fill clones array with intersection of current point with the
+  //middle of the row
+  Int_t sector;
+  Int_t ipart;
+  
+  const Int_t kcmaxhits=30000;
+  AliTPCFastVector * xxxx = new AliTPCFastVector(kcmaxhits*4);
+  AliTPCFastVector & xxx = *xxxx;
+  Int_t maxhits = kcmaxhits;
+      
+  //
+  AliTPChit * tpcHit=0;
+  tpcHit = (AliTPChit*)FirstHit2(-1);
+  Int_t currentIndex=0;
+  Int_t lastrow=-1;  //last writen row
 
-  //stupid sorting
-  Int_t swap;
-  do {
-    swap=0;
-    for (i=0; i<n-1; i++) {
-      if (q[i]<=q[i+1]) continue;
-      Double_t tmp=q[i]; q[i]=q[i+1]; q[i+1]=tmp;
-      swap++;
+  while (tpcHit){
+    if (tpcHit==0) continue;
+    sector=tpcHit->fSector; // sector number
+    ipart=tpcHit->Track();
+    
+    //find row number
+    
+    Float_t  x[3]={tpcHit->X(),tpcHit->Y(),tpcHit->Z()};
+    Int_t    index[3]={1,sector,0};
+    Int_t    currentrow = fTPCParam->GetPadRow(x,index) ;      
+    if (currentrow<0) continue;
+    if (lastrow<0) lastrow=currentrow;
+    if (currentrow==lastrow){
+      if ( currentIndex>=maxhits){
+       maxhits+=kcmaxhits;
+       xxx.ResizeTo(4*maxhits);
+      }     
+      xxx(currentIndex*4)=x[0];
+      xxx(currentIndex*4+1)=x[1];
+      xxx(currentIndex*4+2)=x[2];      
+      xxx(currentIndex*4+3)=tpcHit->fQ;
+      currentIndex++;  
     }
-  } while (swap);
+    else 
+      if (currentIndex>2){
+       Float_t sumx=0;
+       Float_t sumx2=0;
+       Float_t sumx3=0;
+       Float_t sumx4=0;
+       Float_t sumy=0;
+       Float_t sumxy=0;
+       Float_t sumx2y=0;
+       Float_t sumz=0;
+       Float_t sumxz=0;
+       Float_t sumx2z=0;
+       Float_t sumq=0;
+       for (Int_t index=0;index<currentIndex;index++){
+         Float_t x,x2,x3,x4;
+         x=x2=x3=x4=xxx(index*4);
+         x2*=x;
+         x3*=x2;
+         x4*=x3;
+         sumx+=x;
+         sumx2+=x2;
+         sumx3+=x3;
+         sumx4+=x4;
+         sumy+=xxx(index*4+1);
+         sumxy+=xxx(index*4+1)*x;
+         sumx2y+=xxx(index*4+1)*x2;
+         sumz+=xxx(index*4+2);
+         sumxz+=xxx(index*4+2)*x;
+         sumx2z+=xxx(index*4+2)*x2;     
+         sumq+=xxx(index*4+3);
+       }
+       Float_t centralPad = (fTPCParam->GetNPads(sector,lastrow)-1)/2;
+       Float_t det=currentIndex*(sumx2*sumx4-sumx3*sumx3)-sumx*(sumx*sumx4-sumx2*sumx3)+
+         sumx2*(sumx*sumx3-sumx2*sumx2);
+       
+       Float_t detay=sumy*(sumx2*sumx4-sumx3*sumx3)-sumx*(sumxy*sumx4-sumx2y*sumx3)+
+         sumx2*(sumxy*sumx3-sumx2y*sumx2);
+       Float_t detaz=sumz*(sumx2*sumx4-sumx3*sumx3)-sumx*(sumxz*sumx4-sumx2z*sumx3)+
+         sumx2*(sumxz*sumx3-sumx2z*sumx2);
+       
+       Float_t detby=currentIndex*(sumxy*sumx4-sumx2y*sumx3)-sumy*(sumx*sumx4-sumx2*sumx3)+
+         sumx2*(sumx*sumx2y-sumx2*sumxy);
+       Float_t detbz=currentIndex*(sumxz*sumx4-sumx2z*sumx3)-sumz*(sumx*sumx4-sumx2*sumx3)+
+         sumx2*(sumx*sumx2z-sumx2*sumxz);
+       
+       Float_t y=detay/det+centralPad;
+       Float_t z=detaz/det;    
+       Float_t by=detby/det; //y angle
+       Float_t bz=detbz/det; //z angle
+       sumy/=Float_t(currentIndex);
+       sumz/=Float_t(currentIndex);
+       
+       AliComplexCluster cl;
+       cl.fX=z;
+       cl.fY=y;
+       cl.fQ=sumq;
+       cl.fSigmaX2=bz;
+       cl.fSigmaY2=by;
+       cl.fTracks[0]=ipart;
+       
+       AliTPCClustersRow * row = (fClustersArray->GetRow(sector,lastrow));
+       if (row!=0) row->InsertCluster(&cl);
+       currentIndex=0;
+       lastrow=currentrow;
+      } //end of calculating cluster for given row
+               
+  } // end of loop over hits
+  xxxx->Delete();
 
-  Int_t nl=Int_t(low*n), nu=Int_t(up *n);
-  Double_t dedx=0.;
-  for (i=nl; i<=nu; i++) dedx += q[i];
-  dedx /= (nu-nl+1);
-  return dedx;
 }
+//_______________________________________________________________________________
+void AliTPC::Digits2Reco(Int_t firstevent,Int_t lastevent)
+{
+  // produces rec points from digits and writes them on the root file
+  // AliTPCclusters.root
 
-//_________________________________________________________________________
-//
-// Classes for internal tracking use
-//_________________________________________________________________________
-void AliTPCRow::InsertCluster(const AliTPCcluster* c) {
-  //-----------------------------------------------------------------------
-  // Insert a cluster into this pad row in accordence with its y-coordinate
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------------
-  if (num_of_clusters==MAX_CLUSTER_PER_ROW) {
-    cerr<<"AliTPCRow::InsertCluster(): Too many clusters !\n"; return;
+  TDirectory *cwd = gDirectory;
+
+
+  AliTPCParamSR *dig=(AliTPCParamSR *)gDirectory->Get("75x40_100x60");
+  if(dig){
+    printf("You are running 2 pad-length geom hits with 3 pad-length geom digits\n");
+    delete dig;
+    dig = new AliTPCParamSR();
+  }
+  else
+  {
+   dig=(AliTPCParamSR *)gDirectory->Get("75x40_100x60_150x60"); 
+  }
+  if(!dig){
+   printf("No TPC parameters found\n");
+   exit(3);
+  }
+   
+  SetParam(dig);
+  cout<<"AliTPC::Digits2Reco: TPC parameteres have been set"<<endl; 
+  TFile *out;
+  if(!gSystem->Getenv("CONFIG_FILE")){
+    out=TFile::Open("AliTPCclusters.root","recreate");
+  }
+  else {
+    const char *tmp1;
+    const char *tmp2;
+    char tmp3[80];
+    tmp1=gSystem->Getenv("CONFIG_FILE_PREFIX");
+    tmp2=gSystem->Getenv("CONFIG_OUTDIR");
+    sprintf(tmp3,"%s%s/AliTPCclusters.root",tmp1,tmp2);
+    out=TFile::Open(tmp3,"recreate");
+  }
+
+  TStopwatch timer;
+  cout<<"AliTPC::Digits2Reco - determination of rec points begins"<<endl;
+  timer.Start();
+  cwd->cd();
+  for(Int_t iev=firstevent;iev<lastevent+1;iev++){
+
+    printf("Processing event %d\n",iev);
+    Digits2Clusters(iev);
   }
-  if (num_of_clusters==0) {clusters[num_of_clusters++]=c; return;}
-  Int_t i=Find(c->fY);
-  memmove(clusters+i+1 ,clusters+i,(num_of_clusters-i)*sizeof(AliTPCcluster*));
-  clusters[i]=c; num_of_clusters++;
+  cout<<"AliTPC::Digits2Reco - determination of rec points ended"<<endl;
+  timer.Stop();
+  timer.Print();
+  out->Close();
+  cwd->cd(); 
+
+
 }
-//___________________________________________________________________
 
-Int_t AliTPCRow::Find(Double_t y) const {
-  //-----------------------------------------------------------------------
-  // Return the index of the nearest cluster 
-  //
-  // Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
-  //-----------------------------------------------------------------------
-  if (y <= clusters[0]->fY) return 0;
-  if (y > clusters[num_of_clusters-1]->fY) return num_of_clusters;
-  Int_t b=0, e=num_of_clusters-1, m=(b+e)/2;
-  for (; b<e; m=(b+e)/2) {
-    if (y > clusters[m]->fY) b=m+1;
-    else e=m; 
+AliLoader* AliTPC::MakeLoader(const char* topfoldername)
+{
+//Makes TPC loader
+ fLoader = new AliTPCLoader(GetName(),topfoldername);
+ return fLoader;
+}
+
+////////////////////////////////////////////////////////////////////////
+AliTPCParam* AliTPC::LoadTPCParam(TFile *file) {
+//
+// load TPC paarmeters from a given file or create new if the object
+// is not found there
+// 12/05/2003 This method should be moved to the AliTPCLoader
+// and one has to decide where to store the TPC parameters
+// M.Kowalski
+  char paramName[50];
+  sprintf(paramName,"75x40_100x60_150x60");
+  AliTPCParam *paramTPC=(AliTPCParam*)file->Get(paramName);
+  if (paramTPC) {
+    cout<<"TPC parameters "<<paramName<<" found."<<endl;
+  } else {
+    cerr<<"TPC parameters not found. Create new (they may be incorrect)."
+       <<endl;    
+    paramTPC = new AliTPCParamSR;
   }
-  return m;
+  return paramTPC;
+
+// the older version of parameters can be accessed with this code.
+// In some cases, we have old parameters saved in the file but 
+// digits were created with new parameters, it can be distinguish 
+// by the name of TPC TreeD. The code here is just for the case 
+// we would need to compare with old data, uncomment it if needed.
+//
+//  char paramName[50];
+//  sprintf(paramName,"75x40_100x60");
+//  AliTPCParam *paramTPC=(AliTPCParam*)in->Get(paramName);
+//  if (paramTPC) {
+//    cout<<"TPC parameters "<<paramName<<" found."<<endl;
+//  } else {
+//    sprintf(paramName,"75x40_100x60_150x60");
+//    paramTPC=(AliTPCParam*)in->Get(paramName);
+//    if (paramTPC) {
+//     cout<<"TPC parameters "<<paramName<<" found."<<endl;
+//    } else {
+//     cerr<<"TPC parameters not found. Create new (they may be incorrect)."
+//         <<endl;    
+//     paramTPC = new AliTPCParamSR;
+//    }
+//  }
+//  return paramTPC;
+
 }
-//________________________________________________________________________