]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TRD/AliTRDtracker.cxx
running local for SP and LYZEP and new histograms for QC
[u/mrichter/AliRoot.git] / TRD / AliTRDtracker.cxx
index 5950f9a1f4fc29e4e037e831be0d8688101dfc8f..eb00d3241d02511285a3ca9baea7859be75bf1b8 100644 (file)
 
 ///////////////////////////////////////////////////////////////////////////////
 //                                                                           //
-//  The standard TRD tracker                                                 //
+//  The standard TRD tracker                                                 //  
+//  Based on Kalman filltering approach                                      //
+//                                                                           //
+//  Authors:                                                                 //
+//     M. Ivanov  (Marian.Ivanov@cern.ch)                                    //
 //                                                                           //
 ///////////////////////////////////////////////////////////////////////////////
 
-#include <Riostream.h>
-#include <TFile.h>
 #include <TBranch.h>
-#include <TTree.h>  
+#include <TFile.h>
+#include <TGraph.h>
+#include <TLinearFitter.h>
 #include <TObjArray.h> 
+#include <TROOT.h>
+#include <TTree.h>  
+#include <TTreeStream.h>
+
+#include "AliESDEvent.h"
+#include "AliESDtrack.h"
+#include "AliAlignObj.h"
+#include "AliRieman.h"
+#include "AliTrackPointArray.h"
 
 #include "AliTRDgeometry.h"
-#include "AliTRDparameter.h"
-#include "AliTRDgeometryDetail.h"
-#include "AliTRDgeometryHole.h"
+#include "AliTRDpadPlane.h"
+#include "AliTRDgeometry.h"
 #include "AliTRDcluster.h" 
 #include "AliTRDtrack.h"
-#include "AliTRDPartID.h"
-#include "../TPC/AliTPCtrack.h"
-
+#include "AliTRDseed.h"
+#include "AliTRDcalibDB.h"
+#include "AliTRDCommonParam.h"
 #include "AliTRDtracker.h"
+#include "AliTRDReconstructor.h"
+#include "AliTRDrecoParam.h"
+#include "AliTRDCalibraFillHisto.h"
 
-ClassImp(AliTRDtracker) 
-
-  const  Float_t     AliTRDtracker::fgkSeedDepth          = 0.5; 
-  const  Float_t     AliTRDtracker::fgkSeedStep           = 0.10;   
-  const  Float_t     AliTRDtracker::fgkSeedGap            = 0.25;  
-
-  const  Float_t     AliTRDtracker::fgkMaxSeedDeltaZ12    = 40.;  
-  const  Float_t     AliTRDtracker::fgkMaxSeedDeltaZ      = 25.;  
-  const  Float_t     AliTRDtracker::fgkMaxSeedC           = 0.0052; 
-  const  Float_t     AliTRDtracker::fgkMaxSeedTan         = 1.2;  
-  const  Float_t     AliTRDtracker::fgkMaxSeedVertexZ     = 150.; 
-
-  const  Double_t    AliTRDtracker::fgkSeedErrorSY        = 0.2;
-  const  Double_t    AliTRDtracker::fgkSeedErrorSY3       = 2.5;
-  const  Double_t    AliTRDtracker::fgkSeedErrorSZ        = 0.1;
-
-  const  Float_t     AliTRDtracker::fgkMinClustersInSeed  = 0.7;  
-
-  const  Float_t     AliTRDtracker::fgkMinClustersInTrack = 0.5;  
-  const  Float_t     AliTRDtracker::fgkMinFractionOfFoundClusters = 0.8;  
-
-  const  Float_t     AliTRDtracker::fgkSkipDepth          = 0.3;
-  const  Float_t     AliTRDtracker::fgkLabelFraction      = 0.8;  
-  const  Float_t     AliTRDtracker::fgkWideRoad           = 20.;
-
-  const  Double_t    AliTRDtracker::fgkMaxChi2            = 12.; 
-
-const Int_t AliTRDtracker::fgkFirstPlane = 5;
-const Int_t AliTRDtracker::fgkLastPlane = 17;
-
-
-//____________________________________________________________________
-AliTRDtracker::AliTRDtracker():AliTracker(),
-                              fGeom(0),
-                              fPar(0),
-                              fNclusters(0),
-                              fClusters(0),
-                              fNseeds(0),
-                              fSeeds(0),
-                              fNtracks(0),
-                              fTracks(0),
-                              fSY2corr(0),
-                              fSZ2corr(0),
-                              fTimeBinsPerPlane(0),
-                              fMaxGap(0),
-                              fVocal(kFALSE),
-                              fAddTRDseeds(kFALSE),
-                              fNoTilt(kFALSE)
-{
-  for(Int_t i=0;i<kTrackingSectors;i++) fTrSec[i]=0;
-  for(Int_t j=0;j<5;j++)
-    for(Int_t k=0;k<18;k++) fHoles[j][k]=kFALSE;
-} 
-//____________________________________________________________________
-AliTRDtracker::AliTRDtracker(const TFile *geomfile):AliTracker()
+ClassImp(AliTRDtracker)
+
+const  Float_t  AliTRDtracker::fgkMinClustersInTrack =  0.5;  //
+const  Float_t  AliTRDtracker::fgkLabelFraction      =  0.8;  //
+const  Double_t AliTRDtracker::fgkMaxChi2            = 12.0;  //
+const  Double_t AliTRDtracker::fgkMaxSnp             =  0.95; // Maximum local sine of the azimuthal angle
+const  Double_t AliTRDtracker::fgkMaxStep            =  2.0;  // Maximal step size in propagation 
+
+//_____________________________________________________________________________
+AliTRDtracker::AliTRDtracker(AliTRDReconstructor *rec)
+  :AliTracker()
+  ,fReconstructor(rec)
+  ,fGeom(0)
+  ,fNclusters(0)
+  ,fClusters(0)
+  ,fNseeds(0)
+  ,fSeeds(0)
+  ,fNtracks(0)
+  ,fTracks(0)
+  ,fTimeBinsPerPlane(0)
+  ,fAddTRDseeds(kFALSE)
+  ,fNoTilt(kFALSE)
+  ,fHBackfit(0x0)
+  ,fHClSearch(0x0)
+  ,fHRefit(0x0)
+  ,fHX(0x0)
+  ,fHNCl(0x0)
+  ,fHNClTrack(0x0)
+  ,fHMinYPos(0x0)
+  ,fHMinYNeg(0x0)
+  ,fHMinZ(0x0)
+  ,fHMinD(0x0)
+  ,fHDeltaX(0x0)
+  ,fHXCl(0x0)
+  ,fDebugStreamer(0)
 {
-  // 
-  //  Main constructor
-  //  
+  //
+  // Default constructor
+  //
 
-  //Float_t fTzero = 0;
-   
-  fAddTRDseeds = kFALSE;
-  fGeom = NULL;
-  fNoTilt = kFALSE;
-  
-  TDirectory *savedir=gDirectory; 
-  TFile *in=(TFile*)geomfile;  
-  if (!in->IsOpen()) {
-    printf("AliTRDtracker::AliTRDtracker(): geometry file is not open!\n");
-    printf("    DETAIL TRD geometry and DEFAULT TRD parameter will be used\n");
+  for (Int_t i = 0; i < kTrackingSectors; i++) {
+    fTrSec[i] = 0;
   }
-  else {
-    in->cd();  
-//    in->ls();
-    fGeom = (AliTRDgeometry*) in->Get("TRDgeometry");
-    fPar  = (AliTRDparameter*) in->Get("TRDparameter");
-//    fGeom->Dump();
-  }
-
-  if(fGeom) {
-    //    fTzero = geo->GetT0();
-    printf("Found geometry version %d on file \n", fGeom->IsVersion());
-  }
-  else { 
-    printf("AliTRDtracker::AliTRDtracker(): can't find TRD geometry!\n");
-    //printf("The DETAIL TRD geometry will be used\n");
-    //fGeom = new AliTRDgeometryDetail();
-    fGeom = new AliTRDgeometryHole();
-    fGeom->SetPHOShole();
-    fGeom->SetRICHhole();    
-  } 
 
-  if (!fPar) {  
-    printf("AliTRDtracker::AliTRDtracker(): can't find TRD parameter!\n");
-    printf("The DEFAULT TRD parameter will be used\n");
-    fPar = new AliTRDparameter();
-  }
-  fPar->ReInit();
+  InitLogHists();
 
-  savedir->cd();  
+} 
 
+//_____________________________________________________________________________
+AliTRDtracker::AliTRDtracker(const AliTRDtracker &t)
+  :AliTracker(t)
+  ,fReconstructor(t.fReconstructor)
+  ,fGeom(0)
+  ,fNclusters(0)
+  ,fClusters(0)
+  ,fNseeds(0)
+  ,fSeeds(0)
+  ,fNtracks(0)
+  ,fTracks(0)
+  ,fTimeBinsPerPlane(0)
+  ,fAddTRDseeds(kFALSE)
+  ,fNoTilt(kFALSE)
+  ,fHBackfit(0x0)
+  ,fHClSearch(0x0)
+  ,fHRefit(0x0)
+  ,fHX(0x0)
+  ,fHNCl(0x0)
+  ,fHNClTrack(0x0)
+  ,fHMinYPos(0x0)
+  ,fHMinYNeg(0x0)
+  ,fHMinZ(0x0)
+  ,fHMinD(0x0)
+  ,fHDeltaX(0x0)
+  ,fHXCl(0x0)
+  ,fDebugStreamer(0)
+{
+  //
+  // Copy constructor
+  //
 
-  //  fGeom->SetT0(fTzero);
+}
 
-  fNclusters = 0;
-  fClusters  = new TObjArray(2000); 
-  fNseeds    = 0;
-  fSeeds     = new TObjArray(2000);
-  fNtracks   = 0;
-  fTracks    = new TObjArray(1000);
+//_____________________________________________________________________________
+AliTRDtracker::AliTRDtracker(const TFile */*geomfile*/, AliTRDReconstructor *rec)
+  :AliTracker()
+  ,fReconstructor(rec)
+  ,fGeom(0)
+  ,fNclusters(0)
+  ,fClusters(new TObjArray(2000))
+  ,fNseeds(0)
+  ,fSeeds(new TObjArray(2000))
+  ,fNtracks(0)
+  ,fTracks(new TObjArray(1000))
+  ,fTimeBinsPerPlane(0)
+  ,fAddTRDseeds(kFALSE)
+  ,fNoTilt(kFALSE)
+  ,fHBackfit(0x0)
+  ,fHClSearch(0x0)
+  ,fHRefit(0x0)
+  ,fHX(0x0)
+  ,fHNCl(0x0)
+  ,fHNClTrack(0x0)
+  ,fHMinYPos(0x0)
+  ,fHMinYNeg(0x0)
+  ,fHMinZ(0x0)
+  ,fHMinD(0x0)
+  ,fHDeltaX(0x0)
+  ,fHXCl(0x0)
+  ,fDebugStreamer(0)
+{
+  // 
+  //  Main constructor
+  //  
+   
+  TDirectory *savedir = gDirectory; 
 
-  for(Int_t geomS = 0; geomS < kTrackingSectors; geomS++) {
-    Int_t trS = CookSectorIndex(geomS);
-    fTrSec[trS] = new AliTRDtrackingSector(fGeom, geomS, fPar);
-    for (Int_t icham=0;icham<AliTRDgeometry::kNcham; icham++){
-      fHoles[icham][trS]=fGeom->IsHole(0,icham,geomS);
-    }
+  fGeom = new AliTRDgeometry();
+
+  for (Int_t geomS = 0; geomS < kTrackingSectors; geomS++) {
+    Int_t trS   = geomS;
+    fTrSec[trS] = new AliTRDtrackingSector(fGeom,geomS);
   }
 
-  Float_t tiltAngle = TMath::Abs(fPar->GetTiltingAngle()); 
-  if(tiltAngle < 0.1) {
+  AliTRDpadPlane *padPlane = fGeom->GetPadPlane(0,0);
+  Float_t tiltAngle = TMath::Abs(padPlane->GetTiltingAngle());
+  if (tiltAngle < 0.1) {
     fNoTilt = kTRUE;
   }
 
-  fSY2corr = 0.2;
-  fSZ2corr = 120.;      
-
-  if(fNoTilt && (tiltAngle > 0.1)) fSY2corr = fSY2corr + tiltAngle * 0.05; 
-
-
-  // calculate max gap on track
-
-  Double_t dxAmp = (Double_t) fGeom->CamHght();   // Amplification region
-  Double_t dxDrift = (Double_t) fGeom->CdrHght(); // Drift region
-
-  Double_t dx = (Double_t) fPar->GetTimeBinSize();   
-  Int_t tbAmp = fPar->GetTimeBefore();
-  Int_t maxAmp = (Int_t) ((dxAmp+0.000001)/dx);
-  if(kTRUE) maxAmp = 0;  // intentional until we change the parameter class 
-  Int_t tbDrift = fPar->GetTimeMax();
-  Int_t maxDrift = (Int_t) ((dxDrift+0.000001)/dx);
-
-  tbDrift = TMath::Min(tbDrift,maxDrift);
-  tbAmp = TMath::Min(tbAmp,maxAmp);
-
-  fTimeBinsPerPlane = tbAmp + tbDrift;
-  fMaxGap = (Int_t) (fTimeBinsPerPlane * fGeom->Nplan() * fgkSkipDepth);
-
-  fVocal = kFALSE;
-
-
-  // Barrel Tracks [SR, 03.04.2003]
+  if (!AliTRDcalibDB::Instance()) {
+    AliFatal("Could not get calibration object");
+  }
+  fTimeBinsPerPlane = AliTRDcalibDB::Instance()->GetNumberOfTimeBins();
 
-  fBarrelFile = 0;
-  fBarrelTree = 0;
-  fBarrelArray = 0;
-  fBarrelTrack = 0;
+  fDebugStreamer    = new TTreeSRedirector("TRDdebug.root");
 
   savedir->cd();
+  
+  InitLogHists();
+
 }   
 
-//___________________________________________________________________
+//_____________________________________________________________________________
 AliTRDtracker::~AliTRDtracker()
 {
   //
@@ -211,1730 +206,1094 @@ AliTRDtracker::~AliTRDtracker()
     fClusters->Delete();
     delete fClusters;
   }
+
   if (fTracks) {
     fTracks->Delete();
     delete fTracks;
   }
+
   if (fSeeds) {
     fSeeds->Delete();
     delete fSeeds;
   }
-  delete fGeom;  
-  delete fPar;  
 
-  for(Int_t geomS = 0; geomS < kTrackingSectors; geomS++) {
+  if (fGeom) {
+    delete fGeom;  
+  }
+
+  for (Int_t geomS = 0; geomS < kTrackingSectors; geomS++) {
     delete fTrSec[geomS];
   }
-}   
 
-//_____________________________________________________________________
+  if (fDebugStreamer) {    
+    delete fDebugStreamer;
+  }
 
-void AliTRDtracker::SetBarrelTree(const char *mode) {
-  //
-  //
+}   
+
+//_____________________________________________________________________________
+Int_t  AliTRDtracker::LocalToGlobalID(Int_t lid)
+{
   //
+  // Transform internal TRD ID to global detector ID
+  //
+
+  Int_t  isector = fGeom->GetSector(lid);
+  Int_t  istack  = fGeom->GetStack(lid);
+  Int_t  ilayer  = fGeom->GetLayer(lid);
+
+  AliGeomManager::ELayerID iLayer = AliGeomManager::kTRD1;
+  switch (ilayer) {
+  case 0:
+    iLayer = AliGeomManager::kTRD1;
+    break;
+  case 1:
+    iLayer = AliGeomManager::kTRD2;
+    break;
+  case 2:
+    iLayer = AliGeomManager::kTRD3;
+    break;
+  case 3:
+    iLayer = AliGeomManager::kTRD4;
+    break;
+  case 4:
+    iLayer = AliGeomManager::kTRD5;
+    break;
+  case 5:
+    iLayer = AliGeomManager::kTRD6;
+    break;
+  };
+
+  Int_t    modId = isector * fGeom->Nstack() + istack;
+  UShort_t volid = AliGeomManager::LayerToVolUID(iLayer,modId);
+
+  return volid;
 
-  if (!IsStoringBarrel()) return;
+}
 
-  TDirectory *sav = gDirectory;
-  if (!fBarrelFile) fBarrelFile = new TFile("AliBarrelTracks.root", "UPDATE");
+//_____________________________________________________________________________
+Int_t  AliTRDtracker::GlobalToLocalID(Int_t gid)
+{
+  //
+  // Transform global detector ID to local detector ID
+  // 
 
-  char buff[40];
-  sprintf(buff,  "BarrelTRD_%d_%s", GetEventNumber(), mode);
+  Int_t modId    = 0;
+  AliGeomManager::ELayerID layerId = AliGeomManager::VolUIDToLayer(gid,modId);
 
-  fBarrelFile->cd();
-  fBarrelTree = new TTree(buff, "Barrel TPC tracks");
-  
-  Int_t nRefs = fgkLastPlane - fgkFirstPlane + 1;
+  Int_t isector = modId / fGeom->Nstack();
+  Int_t istack  = modId % fGeom->Nstack();
+  Int_t iLayer  = -1;
 
-  if (!fBarrelArray) fBarrelArray = new TClonesArray("AliBarrelTrack", nRefs);
-  for(Int_t i=0; i<nRefs; i++) new((*fBarrelArray)[i]) AliBarrelTrack();
-  
-  fBarrelTree->Branch("tracks", &fBarrelArray);
-  sav->cd();
-}
-  
-//_____________________________________________________________________
+  switch (layerId) {
+  case AliGeomManager::kTRD1:
+    iLayer = 0;
+    break;
+  case AliGeomManager::kTRD2:
+    iLayer = 1;
+    break;
+  case AliGeomManager::kTRD3:
+    iLayer = 2;
+    break;
+  case AliGeomManager::kTRD4:
+    iLayer = 3;
+    break;
+  case AliGeomManager::kTRD5:
+    iLayer = 4;
+    break;
+  case AliGeomManager::kTRD6:
+    iLayer = 5;
+    break;
+  default:
+    iLayer =-1;
+  }
 
-void AliTRDtracker::StoreBarrelTrack(AliTRDtrack *ps, Int_t refPlane, Int_t isIn) {
-  //
-  //
-  //
-  
-  if (!IsStoringBarrel()) return;
-  
-  static Int_t nClusters;
-  static Int_t nWrong;
-  static Double_t chi2;
-  static Int_t index;
-  static Bool_t wasLast = kTRUE;
-  
-  Int_t newClusters, newWrong;
-  Double_t newChi2;
-  
-  if (wasLast) {   
-    fBarrelArray->Clear();
-    nClusters = nWrong = 0;
-    chi2 = 0.0;
-    index = 0;
-    wasLast = kFALSE;
+  if (iLayer < 0) {
+    return -1;
   }
-  
-  fBarrelTrack = (AliBarrelTrack*)(*fBarrelArray)[index++];
-  ps->GetBarrelTrack(fBarrelTrack);
-  
-  newClusters = ps->GetNumberOfClusters() - nClusters; 
-  newWrong = ps->GetNWrong() - nWrong;
-  newChi2 = ps->GetChi2() - chi2;
-  
-  nClusters =  ps->GetNumberOfClusters();
-  nWrong = ps->GetNWrong();
-  chi2 = ps->GetChi2();  
-
-  if (refPlane != fgkLastPlane) {
-    fBarrelTrack->SetNClusters(newClusters, newChi2);
-    fBarrelTrack->SetNWrongClusters(newWrong);
-  } else {
-    wasLast = kTRUE;
-  } 
 
-  fBarrelTrack->SetRefPlane(refPlane, isIn);
-}
+  Int_t lid = fGeom->GetDetector(iLayer,istack,isector);
 
-//_____________________________________________________________________
+  return lid;
 
-Bool_t AliTRDtracker::AdjustSector(AliTRDtrack *track) {
+}
+
+//_____________________________________________________________________________
+Bool_t AliTRDtracker::AdjustSector(AliTRDtrack *track) 
+{
   //
   // Rotates the track when necessary
   //
 
   Double_t alpha = AliTRDgeometry::GetAlpha(); 
-  Double_t y = track->GetY();
-  Double_t ymax = track->GetX()*TMath::Tan(0.5*alpha);
-
-  //Int_t ns = AliTRDgeometry::kNsect;
-  //Int_t s=Int_t(track->GetAlpha()/alpha)%ns; 
-
-  if (y > ymax) {
-    //s = (s+1) % ns;
-    if (!track->Rotate(alpha)) return kFALSE;
-  } else if (y <-ymax) {
-    //s = (s-1+ns) % ns;                           
-    if (!track->Rotate(-alpha)) return kFALSE;   
+  Double_t y     = track->GetY();
+  Double_t ymax  = track->GetX()*TMath::Tan(0.5*alpha);
+
+  if      (y >  ymax) {
+    if (!track->Rotate( alpha)) {
+      return kFALSE;
+    }
+  } 
+  else if (y < -ymax) {
+    if (!track->Rotate(-alpha)) {
+      return kFALSE;   
+    }
   } 
 
   return kTRUE;
+
 }
 
-//_____________________________________________________________________
-inline Double_t f1trd(Double_t x1,Double_t y1,
-                      Double_t x2,Double_t y2,
-                      Double_t x3,Double_t y3)
+//_____________________________________________________________________________
+AliTRDcluster *AliTRDtracker::GetCluster(AliTRDtrack *track, Int_t plane
+                                       , Int_t timebin, UInt_t &index)
 {
   //
-  // Initial approximation of the track curvature
+  // Try to find cluster in the backup list
   //
-  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 f2trd(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 X coordinate
-  // of the center of curvature
-  //
+  AliTRDcluster *cl =0;
+  Int_t *indexes = track->GetBackupIndexes();
 
-  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));
+  for (UInt_t i = 0; i < kMaxTimeBinIndex; i++) {
+    if (indexes[i] == 0) {
+      break;  
+    }
+    AliTRDcluster *cli = (AliTRDcluster *) fClusters->UncheckedAt(indexes[i]);
+    if (!cli) {
+      break;
+    }
+    if (cli->GetLocalTimeBin() != timebin) {
+      continue;
+    }
+    Int_t ilayer = fGeom->GetLayer(cli->GetDetector());
+    if (ilayer == plane) {
+      cl    = cli;
+      index = indexes[i];
+      break;
+    }
+  }
 
-  Double_t xr=TMath::Abs(d/(d*x1-a)), yr=d/(d*y1-b);
+  return cl;
 
-  return -a/(d*y1-b)*xr/sqrt(xr*xr+yr*yr);
-}          
+}
 
-//_____________________________________________________________________
-inline Double_t f3trd(Double_t x1,Double_t y1,
-                      Double_t x2,Double_t y2,
-                      Double_t z1,Double_t z2)
+//_____________________________________________________________________________
+Int_t  AliTRDtracker::GetLastPlane(AliTRDtrack *track)
 {
   //
-  // Initial approximation of the tangent of the track dip angle
+  // Return last updated plane
   //
 
-  return (z1 - z2)/sqrt((x1-x2)*(x1-x2)+(y1-y2)*(y1-y2));
-}            
+  Int_t  lastplane = 0;
+  Int_t *indexes   = track->GetBackupIndexes();
 
-
-AliTRDcluster * AliTRDtracker::GetCluster(AliTRDtrack * track, Int_t plane, Int_t timebin){
-  //
-  //try to find cluster in the backup list
-  //
-  AliTRDcluster * cl =0;
-  UInt_t *indexes = track->GetBackupIndexes();
-  for (UInt_t i=0;i<kMaxTimeBinIndex;i++){
-    if (indexes[i]==0) break;  
-    AliTRDcluster * cli = (AliTRDcluster*)fClusters->UncheckedAt(indexes[i]);
-    if (!cli) break;
-    if (cli->GetLocalTimeBin()!=timebin) continue;
-    Int_t iplane = fGeom->GetPlane(cli->GetDetector());
-    if (iplane==plane) {
-      cl = cli;
+  for (UInt_t i = 0; i < kMaxTimeBinIndex; i++) {
+    AliTRDcluster *cli = (AliTRDcluster *) fClusters->UncheckedAt(indexes[i]);
+    if (!cli) {
       break;
     }
-  }
-  return cl;
-}
-
-
-Int_t  AliTRDtracker::GetLastPlane(AliTRDtrack * track){
-  //
-  //return last updated plane
-  Int_t lastplane=0;
-  UInt_t *indexes = track->GetBackupIndexes();
-  for (UInt_t i=0;i<kMaxTimeBinIndex;i++){
-    AliTRDcluster * cli = (AliTRDcluster*)fClusters->UncheckedAt(indexes[i]);
-    if (!cli) break;
-    Int_t iplane = fGeom->GetPlane(cli->GetDetector());
-    if (iplane>lastplane) {
-      lastplane = iplane;
+    Int_t ilayer = fGeom->GetLayer(cli->GetDetector());
+    if (ilayer > lastplane) {
+      lastplane = ilayer;
     }
   }
+
   return lastplane;
+
 }
-//___________________________________________________________________
-Int_t AliTRDtracker::Clusters2Tracks(const TFile *inp, TFile *out)
+     
+//_____________________________________________________________________________
+Int_t AliTRDtracker::PropagateBack(AliESDEvent *event) 
 {
   //
-  // Finds tracks within the TRD. File <inp> is expected to contain seeds 
-  // at the outer part of the TRD. If <inp> is NULL, the seeds
-  // are found within the TRD if fAddTRDseeds is TRUE. 
-  // The tracks are propagated to the innermost time bin 
-  // of the TRD and stored in file <out>. 
-  //
-
-  LoadEvent();
-  TDirectory *savedir=gDirectory;
-
-  char   tname[100];
-
-  if (!out->IsOpen()) {
-    cerr<<"AliTRDtracker::Clusters2Tracks(): output file is not open !\n";
-    return 1;
-  }    
-
-  sprintf(tname,"seedTRDtoTPC_%d",GetEventNumber()); 
-  TTree tpcTree(tname,"Tree with seeds from TRD at outer TPC pad row");
-  AliTPCtrack *iotrack=0;
-  tpcTree.Branch("tracks","AliTPCtrack",&iotrack,32000,0); 
-
-  sprintf(tname,"TreeT%d_TRD",GetEventNumber());
-  TTree trdTree(tname,"TRD tracks at inner TRD time bin");
-  AliTRDtrack *iotrackTRD=0;
-  trdTree.Branch("tracks","AliTRDtrack",&iotrackTRD,32000,0);  
-
-  Int_t timeBins = fTrSec[0]->GetNumberOfTimeBins();
-  Float_t foundMin = fgkMinClustersInTrack * timeBins; 
-
-  if (inp) {
-     TFile *in=(TFile*)inp;
-     if (!in->IsOpen()) {
-        cerr<<
-          "AliTRDtracker::Clusters2Tracks(): file with seeds is not open !\n";
-        cerr<<" ... going for seeds finding inside the TRD\n";
-     }
-     else {
-       in->cd();
-       sprintf(tname,"TRDb_%d",GetEventNumber());  
-       TTree *seedTree=(TTree*)in->Get(tname);  
-       if (!seedTree) {
-         cerr<<"AliTRDtracker::Clusters2Tracks(): ";
-         cerr<<"can't get a tree with track seeds !\n";
-         return 3;
-       }  
-       AliTRDtrack *seed=new AliTRDtrack;
-       seedTree->SetBranchAddress("tracks",&seed);
-
-       Int_t n=(Int_t)seedTree->GetEntries();
-       for (Int_t i=0; i<n; i++) {
-         seedTree->GetEvent(i);
-         seed->ResetCovariance(); 
-         AliTRDtrack *tr = new AliTRDtrack(*seed,seed->GetAlpha());
-         fSeeds->AddLast(tr);
-         fNseeds++;
-       }          
-       delete seed;
-       delete seedTree;
-     }
-  }
-
-  out->cd();
-
-
-  // find tracks from loaded seeds
-
-  Int_t nseed=fSeeds->GetEntriesFast();
-  Int_t i, found = 0;
-  Int_t innerTB = fTrSec[0]->GetInnerTimeBin();
-
-  for (i=0; i<nseed; i++) {   
-    AliTRDtrack *pt=(AliTRDtrack*)fSeeds->UncheckedAt(i), &t=*pt; 
-    FollowProlongation(t, innerTB); 
-    if (t.GetNumberOfClusters() >= foundMin) {
-      UseClusters(&t);
-      CookLabel(pt, 1-fgkLabelFraction);
-      //      t.CookdEdx();
-    }
-    iotrackTRD = pt;
-    trdTree.Fill();
-    found++;
-//    cout<<found<<'\r';     
-
-    if(PropagateToTPC(t)) {
-      AliTPCtrack *tpc = new AliTPCtrack(*pt,pt->GetAlpha());
-      iotrack = tpc;
-      tpcTree.Fill();
-      delete tpc;
-    }  
-    delete fSeeds->RemoveAt(i);
-    fNseeds--;
-  }     
-
-  cout<<"Number of loaded seeds: "<<nseed<<endl;  
-  cout<<"Number of found tracks from loaded seeds: "<<found<<endl;
-
-  // after tracks from loaded seeds are found and the corresponding 
-  // clusters are used, look for additional seeds from TRD
+  // Gets seeds from ESD event. The seeds are AliTPCtrack's found and
+  // backpropagated by the TPC tracker. Each seed is first propagated 
+  // to the TRD, and then its prolongation is searched in the TRD.
+  // If sufficiently long continuation of the track is found in the TRD
+  // the track is updated, otherwise it's stored as originaly defined 
+  // by the TPC tracker.   
+  //  
 
-  if(fAddTRDseeds) { 
-    // Find tracks for the seeds in the TRD
-    Int_t timeBins = fTrSec[0]->GetNumberOfTimeBins();
-  
-    Int_t nSteps = (Int_t) (fgkSeedDepth / fgkSeedStep);
-    Int_t gap = (Int_t) (timeBins * fgkSeedGap);
-    Int_t step = (Int_t) (timeBins * fgkSeedStep);
+       Int_t   found    = 0;     // number of tracks found
+       Float_t foundMin = 20.0;
+       
+       Int_t    nSeed   = event->GetNumberOfTracks();
+       if(!nSeed){
+               // run stand alone tracking
+               if (fReconstructor->IsSeeding()) Clusters2Tracks(event);
+               return 0;
+       }
+       
+       Float_t *quality = new Float_t[nSeed];
+       Int_t   *index   = new Int_t[nSeed];
+       for (Int_t iSeed = 0; iSeed < nSeed; iSeed++) {
+               AliESDtrack *seed = event->GetTrack(iSeed);
+               Double_t covariance[15];
+               seed->GetExternalCovariance(covariance);
+               quality[iSeed] = covariance[0] + covariance[2];
+       }
+       // Sort tracks according to covariance of local Y and Z
+       TMath::Sort(nSeed,quality,index,kFALSE);
+       
+       // Backpropagate all seeds
+       for (Int_t iSeed = 0; iSeed < nSeed; iSeed++) {
+       
+               // Get the seeds in sorted sequence
+               AliESDtrack *seed = event->GetTrack(index[iSeed]);
+               fHBackfit->Fill(0);   // All seeds
+       
+               // Check the seed status
+               ULong_t status = seed->GetStatus();
+               if ((status & AliESDtrack::kTPCout) == 0) {
+                       fHBackfit->Fill(1); // TPC outer edge reached
+                       continue;
+               }
+               if ((status & AliESDtrack::kTRDout) != 0) {
+                       fHBackfit->Fill(2); // TRD outer edge reached (does this happen ?)
+                       continue;
+               }
+       
+               // Do the back prolongation
+               Int_t   lbl         = seed->GetLabel();
+               AliTRDtrack *track  = new AliTRDtrack(*seed);
+               track->SetSeedLabel(lbl);
+               seed->UpdateTrackParams(track,AliESDtrack::kTRDbackup); // Make backup
+               fNseeds++;
+               Float_t p4          = track->GetC();
+               Int_t   expectedClr = FollowBackProlongation(*track);
+               fHBackfit->Fill(3);   // Back prolongation done
+               fHX->Fill(track->GetX());
+       
+               if ((TMath::Abs(track->GetC() - p4) / TMath::Abs(p4) < 0.2) ||
+                               (track->Pt()                                     > 0.8)) {
+                       
+                       fHBackfit->Fill(4);
+                       
+                       //
+                       // Make backup for back propagation
+                       //
+                       
+                       Int_t foundClr = track->GetNumberOfClusters();
+                       if (foundClr >= foundMin) {
+                               track->CookdEdx();
+                               track->CookdEdxTimBin(seed->GetID()); // A.Bercuci 25.07.07
+                               CookLabel(track,1 - fgkLabelFraction);
+                               if (track->GetBackupTrack()) UseClusters(track->GetBackupTrack());
+                               
+                               
+                               // Sign only gold tracks
+                               if (track->GetChi2() / track->GetNumberOfClusters() < 4) {
+                                       if ((seed->GetKinkIndex(0)      ==   0) &&
+                                                       (track->Pt()                <  1.5)) {
+                                                                       UseClusters(track);
+                                       }
+                               }
+                               Bool_t isGold = kFALSE;
+       
+                               // Full gold track
+                               if (track->GetChi2() / track->GetNumberOfClusters() < 5) {
+                                       //seed->UpdateTrackParams(track, AliESDtrack::kTRDbackup);
+                                       if (track->GetBackupTrack()) {
+                                               seed->UpdateTrackParams(track->GetBackupTrack(),AliESDtrack::kTRDbackup);
+                                       }
+                                       isGold = kTRUE;
+                                       //fHBackfit->Fill()
+                               }
+       
+                               // Almost gold track
+                               if ((!isGold)  && (track->GetNCross() == 0) &&
+                                               (track->GetChi2() / track->GetNumberOfClusters()  < 7)) {
+                                       //seed->UpdateTrackParams(track, AliESDtrack::kTRDbackup);
+                                       if (track->GetBackupTrack()) {
+                                               seed->UpdateTrackParams(track->GetBackupTrack(),AliESDtrack::kTRDbackup);
+                                       }
+                                       isGold = kTRUE;
+                               }
+                               
+                               if ((!isGold) && (track->GetBackupTrack())) {
+                                       if ((track->GetBackupTrack()->GetNumberOfClusters() > foundMin) && ((track->GetBackupTrack()->GetChi2()/(track->GetBackupTrack()->GetNumberOfClusters()+1)) < 7)) {
+                                               seed->UpdateTrackParams(track->GetBackupTrack(),AliESDtrack::kTRDbackup);
+                                               isGold = kTRUE;
+                                       }
+                               }
+       
+                               if ((track->StatusForTOF() > 0) && (track->GetNCross() == 0) && (Float_t(track->GetNumberOfClusters()) / Float_t(track->GetNExpected())  > 0.4)) {
+                                       //seed->UpdateTrackParams(track->GetBackupTrack(), AliESDtrack::kTRDbackup);
+                               }
+                       }
+               }
+               /**/
+       
+               /**/
+               // Debug part of tracking
+               TTreeSRedirector &cstream = *fDebugStreamer;
+               Int_t eventNrInFile = event->GetEventNumberInFile(); // This is most likely NOT the event number you'd like to use. It has nothing to do with the 'real' event number.
+               if (fReconstructor->GetStreamLevel(AliTRDReconstructor::kTracker) > 0) {
+                       if (track->GetBackupTrack()) {
+                               cstream << "Tracks"
+                               << "EventNrInFile="  << eventNrInFile
+                               << "ESD.="     << seed
+                               << "trd.="     << track
+                               << "trdback.=" << track->GetBackupTrack()
+                               << "\n";
+                       }
+                       else {
+                               cstream << "Tracks"
+                               << "EventNrInFile="  << eventNrInFile
+                               << "ESD.="     << seed
+                               << "trd.="     << track
+                               << "trdback.=" << track
+                               << "\n";
+                       }
+               }
+               /**/
+       
+               // Propagation to the TOF (I.Belikov)
+               if (track->GetStop() == kFALSE) {
+                       fHBackfit->Fill(5);
+       
+                       Double_t xtof  = 371.0;
+                       Double_t xTOF0 = 370.0;
+               
+                       Double_t c2    = track->GetSnp() + track->GetC() * (xtof - track->GetX());
+                       if (TMath::Abs(c2) >= 0.99) {
+                               fHBackfit->Fill(6);
+                               delete track;
+                               continue;
+                       }
+                       
+                       PropagateToX(*track,xTOF0,fgkMaxStep);
+       
+                       // Energy losses taken to the account - check one more time
+                       c2 = track->GetSnp() + track->GetC() * (xtof - track->GetX());
+                       if (TMath::Abs(c2) >= 0.99) {
+                               fHBackfit->Fill(7);
+                               delete track;
+                               continue;
+                       }
+                       
+                       //if (!PropagateToX(*track,xTOF0,fgkMaxStep)) {
+                       //      fHBackfit->Fill(7);
+                       //delete track;
+                       //      continue;
+                       //}
+       
+                       Double_t ymax = xtof * TMath::Tan(0.5 * AliTRDgeometry::GetAlpha());
+                       Double_t y;
+                       track->GetYAt(xtof,GetBz(),y);
+                       if (y >  ymax) {
+                               if (!track->Rotate( AliTRDgeometry::GetAlpha())) {
+                                       fHBackfit->Fill(8);
+                                       delete track;
+                                       continue;
+                               }
+                       }
+                       else if (y < -ymax) {
+                               if (!track->Rotate(-AliTRDgeometry::GetAlpha())) {
+                                       fHBackfit->Fill(9);
+                                       delete track;
+                                       continue;
+                               }
+                       }
+                                       
+                       if (track->PropagateTo(xtof)) {
+                               seed->UpdateTrackParams(track,AliESDtrack::kTRDout);
+                               fHBackfit->Fill(10);
+       
+        seed->SetNumberOfTRDslices(AliTRDtrack::kNslice);
+                               for (Int_t i = 0; i < AliTRDtrack::kNplane; i++) {
+                                       for (Int_t j = 0; j < AliTRDtrack::kNslice; j++) {
+                                               seed->SetTRDslice(track->GetPIDsignals(i,j),i,j);
+                                       }
+                                       seed->SetTRDTimBin(track->GetPIDTimBin(i),i);
+                               }
+                               //seed->SetTRDtrack(new AliTRDtrack(*track));
+                               if (track->GetNumberOfClusters() > foundMin) {
+                                       fHBackfit->Fill(11);
+                                                               found++;
+                               }
+                       }
+               }
+               else {                  
+                       fHBackfit->Fill(12);
+                       
+                       if ((track->GetNumberOfClusters() >              15) &&
+                                       (track->GetNumberOfClusters() > 0.5*expectedClr)) {
+                               seed->UpdateTrackParams(track,AliESDtrack::kTRDout);
+                               fHBackfit->Fill(13);
+       
+                               //seed->SetStatus(AliESDtrack::kTRDStop);
+
+        seed->SetNumberOfTRDslices(AliTRDtrack::kNslice);
+                               for (Int_t i = 0; i < AliTRDtrack::kNplane; i++) {
+                                       for (Int_t j = 0; j <AliTRDtrack::kNslice; j++) {
+                                               seed->SetTRDslice(track->GetPIDsignals(i,j),i,j);
+                                       }
+                                       seed->SetTRDTimBin(track->GetPIDTimBin(i),i);
+                               }
+                               //seed->SetTRDtrack(new AliTRDtrack(*track));
+                               found++;
+                       }
+               }
+       
+               seed->SetTRDQuality(track->StatusForTOF());
+               seed->SetTRDBudget(track->GetBudget(0));
+       
+               fHBackfit->Fill(14);
+               delete track;
+       }
+       
+       AliInfo(Form("Number of seeds: %d",fNseeds));
+       AliInfo(Form("Number of back propagated TRD tracks: %d",found));
+               
+       fSeeds->Clear();
+       fNseeds = 0;
+       
+       delete [] index;
+       delete [] quality;
+       
+       SaveLogHists();
   
-    // make a first turn with tight cut on initial curvature
-    for(Int_t turn = 1; turn <= 2; turn++) {
-      if(turn == 2) {
-        nSteps = (Int_t) (fgkSeedDepth / (3*fgkSeedStep));
-        step = (Int_t) (timeBins * (3*fgkSeedStep));
-      }
-      for(Int_t i=0; i<nSteps; i++) {
-        Int_t outer=timeBins-1-i*step; 
-        Int_t inner=outer-gap;
+  return 0;
+}
 
-        nseed=fSeeds->GetEntriesFast();
-      
-        MakeSeeds(inner, outer, turn);
-      
-        nseed=fSeeds->GetEntriesFast();
-       //        printf("\n turn %d, step %d: number of seeds for TRD inward %d\n", 
-       //               turn, i, nseed); 
-              
-        for (Int_t i=0; i<nseed; i++) {   
-          AliTRDtrack *pt=(AliTRDtrack*)fSeeds->UncheckedAt(i), &t=*pt; 
-          FollowProlongation(t,innerTB); 
-          if (t.GetNumberOfClusters() >= foundMin) {
-            UseClusters(&t);
-            CookLabel(pt, 1-fgkLabelFraction);
-            t.CookdEdx();
-            found++;
-//            cout<<found<<'\r';     
-            iotrackTRD = pt;
-            trdTree.Fill();
-            if(PropagateToTPC(t)) {
-              AliTPCtrack *tpc = new AliTPCtrack(*pt,pt->GetAlpha());
-              iotrack = tpc;
-              tpcTree.Fill();
-              delete tpc;
-            }        
-          }
-          delete fSeeds->RemoveAt(i);
-          fNseeds--;
-        }
-      }
-    }
-  }
-  tpcTree.Write(); 
-  trdTree.Write(); 
-  
-  cout<<"Total number of found tracks: "<<found<<endl;
-    
-  UnloadEvent();
-    
-  savedir->cd();  
-  
-  return 0;    
-}     
-          
-//___________________________________________________________________
-Int_t AliTRDtracker::Clusters2Tracks(AliESD* event)
+//_____________________________________________________________________________
+Int_t AliTRDtracker::RefitInward(AliESDEvent *event)
 {
   //
-  // Finds tracks within the TRD. The ESD event is expected to contain seeds 
-  // at the outer part of the TRD. The seeds
-  // are found within the TRD if fAddTRDseeds is TRUE. 
+  // Refits tracks within the TRD. The ESD event is expected to contain seeds 
+  // at the outer part of the TRD. 
   // The tracks are propagated to the innermost time bin 
   // of the TRD and the ESD event is updated
+  // Origin: Thomas KUHR (Thomas.Kuhr@cern.ch)
   //
 
-  Int_t timeBins = fTrSec[0]->GetNumberOfTimeBins();
-  Float_t foundMin = fgkMinClustersInTrack * timeBins; 
-  Int_t nseed = 0;
-  Int_t found = 0;
-  Int_t innerTB = fTrSec[0]->GetInnerTimeBin();
-
+  //Int_t   timeBins = fTrSec[0]->GetNumberOfTimeBins();
+  //Float_t foundMin = fgkMinClustersInTrack * timeBins; 
+  Int_t   nseed    = 0;
+  Int_t   found    = 0;
+  Int_t   pidQ     = 0;
+  //Int_t innerTB    = fTrSec[0]->GetInnerTimeBin();
+  AliTRDtrack seed2;
+  
+  // Calibration fill 2D
+  AliTRDCalibraFillHisto *calibra = AliTRDCalibraFillHisto::Instance();
+  if (!calibra) {
+    AliInfo("Could not get Calibra instance\n");
+  }
+  
   Int_t n = event->GetNumberOfTracks();
-  for (Int_t i=0; i<n; i++) {
-    AliESDtrack* seed=event->GetTrack(i);
-    ULong_t status=seed->GetStatus();
-    if ( (status & AliESDtrack::kTRDout ) == 0 ) continue;
-    if ( (status & AliESDtrack::kTRDin) != 0 ) continue;
-    nseed++;
-
-    AliTRDtrack* seed2 = new AliTRDtrack(*seed);
-    //seed2->ResetCovariance(); 
-    AliTRDtrack *pt = new AliTRDtrack(*seed2,seed2->GetAlpha());
-    AliTRDtrack &t=*pt; 
-    FollowProlongation(t, innerTB); 
-    if (t.GetNumberOfClusters() >= foundMin) {
-      UseClusters(&t);
-      CookLabel(pt, 1-fgkLabelFraction);
-      //      t.CookdEdx();
+  for (Int_t i = 0; i < n; i++) {
+
+    AliESDtrack *seed = event->GetTrack(i);
+    new (&seed2) AliTRDtrack(*seed);
+    fHRefit->Fill(0);
+
+    if (seed2.GetX() < 270.0) {
+      seed->UpdateTrackParams(&seed2,AliESDtrack::kTRDbackup); // Backup TPC track - only update
+      fHRefit->Fill(1);
+      continue;
     }
-    found++;
-//    cout<<found<<'\r';     
 
-    if(PropagateToTPC(t)) {
-      seed->UpdateTrackParams(pt, AliESDtrack::kTRDin);
-    }  
-    delete seed2;
-    delete pt;
-  }     
+    ULong_t status = seed->GetStatus();
+    if ((status & AliESDtrack::kTRDout) == 0) {
+      fHRefit->Fill(2);
+      continue;
+    }
+    if ((status & AliESDtrack::kTRDin)  != 0) {
+      fHRefit->Fill(3);
+      continue;
+    }
+    
+    nseed++; 
+    fHRefit->Fill(4);
 
-  cout<<"Number of loaded seeds: "<<nseed<<endl;  
-  cout<<"Number of found tracks from loaded seeds: "<<found<<endl;
+    seed2.ResetCovariance(50.0); 
 
-  // after tracks from loaded seeds are found and the corresponding 
-  // clusters are used, look for additional seeds from TRD
+    AliTRDtrack *pt = new AliTRDtrack(seed2,seed2.GetAlpha());
+    Int_t *indexes2 = seed2.GetIndexes();
+    for (Int_t l = 0; l < AliTRDtrack::kNplane;++l) {
+      for (Int_t j = 0; j < AliTRDtrack::kNslice;j++) {
+        pt->SetPIDsignals(seed2.GetPIDsignals(l,j),l,j);
+      }
+      pt->SetPIDTimBin(seed2.GetPIDTimBin(l),l);
+    }
 
-  if(fAddTRDseeds) { 
-    // Find tracks for the seeds in the TRD
-    Int_t timeBins = fTrSec[0]->GetNumberOfTimeBins();
-  
-    Int_t nSteps = (Int_t) (fgkSeedDepth / fgkSeedStep);
-    Int_t gap = (Int_t) (timeBins * fgkSeedGap);
-    Int_t step = (Int_t) (timeBins * fgkSeedStep);
-  
-    // make a first turn with tight cut on initial curvature
-    for(Int_t turn = 1; turn <= 2; turn++) {
-      if(turn == 2) {
-        nSteps = (Int_t) (fgkSeedDepth / (3*fgkSeedStep));
-        step = (Int_t) (timeBins * (3*fgkSeedStep));
+    Int_t *indexes3 = pt->GetBackupIndexes();
+    for (Int_t l = 0; l < 200;++l) {
+      if (indexes2[l] == 0) {
+        break;
       }
-      for(Int_t i=0; i<nSteps; i++) {
-        Int_t outer=timeBins-1-i*step; 
-        Int_t inner=outer-gap;
+      indexes3[l] = indexes2[l];
+    }  
+        
+    FollowProlongation(*pt); 
+    pt->CookdEdx();
+    pt->CookdEdxTimBin(seed->GetID());
+
+    //calculate PID methods    
+    pt->SetPIDMethod(AliTRDtrack::kLQ);
+    pt->CookPID(pidQ);
+    seed->SetTRDpid(pt->GetPID());
+    seed->SetTRDpidQuality(pidQ);
+
+    // update calibration
+    if(calibra->GetHisto2d()) calibra->UpdateHistograms(pt);
+    found++;
 
-        nseed=fSeeds->GetEntriesFast();
-      
-        MakeSeeds(inner, outer, turn);
-      
-        nseed=fSeeds->GetEntriesFast();
-       //        printf("\n turn %d, step %d: number of seeds for TRD inward %d\n", 
-       //               turn, i, nseed); 
-              
-        for (Int_t i=0; i<nseed; i++) {   
-          AliTRDtrack *pt=(AliTRDtrack*)fSeeds->UncheckedAt(i), &t=*pt; 
-          FollowProlongation(t,innerTB); 
-          if (t.GetNumberOfClusters() >= foundMin) {
-            UseClusters(&t);
-            CookLabel(pt, 1-fgkLabelFraction);
-            t.CookdEdx();
-           found++;
-//            cout<<found<<'\r';     
-            if(PropagateToTPC(t)) {
-             AliESDtrack track;
-             track.UpdateTrackParams(pt,AliESDtrack::kTRDin);
-             event->AddTrack(&track);
-            }        
+    Double_t xTPC = 250.0;
+    if (PropagateToX(*pt,xTPC,fgkMaxStep)) {
+      seed->UpdateTrackParams(pt,AliESDtrack::kTRDrefit);
+      fHRefit->Fill(5);
+
+      for (Int_t l = 0; l < AliTRDtrack::kNplane; ++l) {
+        for (Int_t j = 0; j < AliTRDtrack::kNslice; j++) {
+          seed->SetTRDslice(pt->GetPIDsignals(l,j),l,j);
+        }
+        seed->SetTRDTimBin(pt->GetPIDTimBin(l),l);
+      }
+    } else {
+      // If not prolongation to TPC - propagate without update
+      fHRefit->Fill(5);
+      AliTRDtrack *seed2t = new AliTRDtrack(*seed);
+      seed2t->ResetCovariance(5.0); 
+      AliTRDtrack *pt2   = new AliTRDtrack(*seed2t,seed2t->GetAlpha());
+      delete seed2t;
+
+      if (PropagateToX(*pt2,xTPC,fgkMaxStep)) { 
+        pt2->CookdEdx(); 
+        pt2->CookdEdxTimBin(seed->GetID()); 
+        seed->UpdateTrackParams(pt2,AliESDtrack::kTRDrefit);
+        fHRefit->Fill(6);
+
+        for (Int_t l = 0; l < AliTRDtrack::kNplane; ++l) {
+          for (Int_t j = 0; j < AliTRDtrack::kNslice; j++) {
+            seed->SetTRDslice(pt2->GetPIDsignals(l,j),l,j);
           }
-          delete fSeeds->RemoveAt(i);
-          fNseeds--;
+          seed->SetTRDTimBin(pt2->GetPIDTimBin(l),l);
         }
       }
-    }
-  }
-  
-  cout<<"Total number of found tracks: "<<found<<endl;
-    
-  return 0;    
-}     
-     
-  
 
-//_____________________________________________________________________________
-Int_t AliTRDtracker::PropagateBack(const TFile *inp, TFile *out) {
-  //
-  // Reads seeds from file <inp>. The seeds are AliTPCtrack's found and
-  // backpropagated by the TPC tracker. Each seed is first propagated 
-  // to the TRD, and then its prolongation is searched in the TRD.
-  // If sufficiently long continuation of the track is found in the TRD
-  // the track is updated, otherwise it's stored as originaly defined 
-  // by the TPC tracker.   
-  //  
+      // Add TRD track to ESDfriendTrack - maybe this tracks are
+      // not useful for post-processing - TODO make decision
+      if (fReconstructor->GetStreamLevel(AliTRDReconstructor::kTracker) > 0)  {
+        seed->AddCalibObject(new AliTRDtrack(*pt2/*, kTRUE*/));
+      }
+      delete pt2;
 
-  LoadEvent();
+    }
 
-  TDirectory *savedir=gDirectory;
+    // Add TRD track to ESDfriendTrack
+    if (fReconstructor->GetStreamLevel(AliTRDReconstructor::kTracker) > 0)  {
+      seed->AddCalibObject(new AliTRDtrack(*pt/*, kTRUE*/));
+    }
+    delete pt;
 
-  TFile *in=(TFile*)inp;
+  }   
 
-  if (!in->IsOpen()) {
-     cerr<<"AliTRDtracker::PropagateBack(): ";
-     cerr<<"file with back propagated TPC tracks is not open !\n";
-     return 1;
-  }                   
+  AliInfo(Form("Number of loaded seeds: %d",nseed));
+  AliInfo(Form("Number of found tracks from loaded seeds: %d",found));
 
-  if (!out->IsOpen()) {
-     cerr<<"AliTRDtracker::PropagateBack(): ";
-     cerr<<"file for back propagated TRD tracks is not open !\n";
-     return 2;
-  }      
+  SaveLogHists();
 
-  in->cd();
-  char   tname[100];
-  sprintf(tname,"seedsTPCtoTRD_%d",GetEventNumber());       
-  TTree *seedTree=(TTree*)in->Get(tname);
-  if (!seedTree) {
-     cerr<<"AliTRDtracker::PropagateBack(): ";
-     cerr<<"can't get a tree with seeds from TPC !\n";
-     cerr<<"check if your version of TPC tracker creates tree "<<tname<<"\n";
-     return 3;
-  }
+  return 0;
 
-  AliTPCtrack *seed=new AliTPCtrack;
-  seedTree->SetBranchAddress("tracks",&seed);
+}
 
-  Int_t n=(Int_t)seedTree->GetEntries();
-  for (Int_t i=0; i<n; i++) {
-     seedTree->GetEvent(i);
-     Int_t lbl = seed->GetLabel();
-     AliTRDtrack *tr = new AliTRDtrack(*seed,seed->GetAlpha());
-     tr->SetSeedLabel(lbl);
-     fSeeds->AddLast(tr);
-     fNseeds++;
-  }
+//_____________________________________________________________________________
+Int_t AliTRDtracker::FollowProlongation(AliTRDtrack &t)
+{
+  //
+  // Starting from current position on track=t this function tries
+  // to extrapolate the track up to timeBin=0 and to confirm prolongation
+  // if a close cluster is found. Returns the number of clusters
+  // expected to be found in sensitive layers
+  // GeoManager used to estimate mean density
+  //
 
-  delete seed;
-  delete seedTree;
+  Int_t    sector;
+  Int_t    lastplane = GetLastPlane(&t);
+  Double_t xx0 = 0.0;
+  Double_t xrho= 0.0;
+  Int_t    expectedNumberOfClusters = 0;
 
-  out->cd();
+  for (Int_t iplane = lastplane; iplane >= 0; iplane--) {
 
-  AliTPCtrack *otrack=0;
+    Int_t row0    = GetGlobalTimeBin(0,iplane,GetTimeBinsPerPlane()-1);
+    Int_t rowlast = GetGlobalTimeBin(0,iplane,0);
 
-  sprintf(tname,"seedsTRDtoTOF1_%d",GetEventNumber());  
-  TTree tofTree1(tname,"Tracks back propagated through TPC and TRD");
-  tofTree1.Branch("tracks","AliTPCtrack",&otrack,32000,0);  
+    // Propagate track close to the plane if neccessary
+    Double_t currentx  = fTrSec[0]->GetLayer(rowlast)->GetX();
+    if (currentx < (-fgkMaxStep + t.GetX())) {
+      // Propagate closer to chamber - safety space fgkMaxStep
+      if (!PropagateToX(t,currentx+fgkMaxStep,fgkMaxStep)) {
+       break;
+      }
+    }
 
-  sprintf(tname,"seedsTRDtoTOF2_%d",GetEventNumber());  
-  TTree tofTree2(tname,"Tracks back propagated through TPC and TRD");
-  tofTree2.Branch("tracks","AliTPCtrack",&otrack,32000,0);  
-
-  sprintf(tname,"seedsTRDtoPHOS_%d",GetEventNumber());  
-  TTree phosTree(tname,"Tracks back propagated through TPC and TRD");
-  phosTree.Branch("tracks","AliTPCtrack",&otrack,32000,0);  
-
-  sprintf(tname,"seedsTRDtoRICH_%d",GetEventNumber());  
-  TTree richTree(tname,"Tracks back propagated through TPC and TRD");
-  richTree.Branch("tracks","AliTPCtrack",&otrack,32000,0);  
-
-  sprintf(tname,"TRDb_%d",GetEventNumber());  
-  TTree trdTree(tname,"Back propagated TRD tracks at outer TRD time bin");
-  AliTRDtrack *otrackTRD=0;
-  trdTree.Branch("tracks","AliTRDtrack",&otrackTRD,32000,0);   
-     
-  if (IsStoringBarrel()) SetBarrelTree("back");
-  out->cd();
-
-  Int_t found=0;  
-  Int_t nseed=fSeeds->GetEntriesFast();
-
-  //  Float_t foundMin = fgkMinClustersInTrack * fTimeBinsPerPlane * fGeom->Nplan(); 
-  Float_t foundMin = 40;
-
-  Int_t outermostTB  = fTrSec[0]->GetOuterTimeBin();
-
-  for (Int_t i=0; i<nseed; i++) {  
-
-    AliTRDtrack *ps=(AliTRDtrack*)fSeeds->UncheckedAt(i), &s=*ps;
-    Int_t expectedClr = FollowBackProlongation(s);
-
-    if (IsStoringBarrel()) {
-      StoreBarrelTrack(ps, fgkLastPlane, kTrackBack);
-      fBarrelTree->Fill();        
-    }
-
-    Int_t foundClr = s.GetNumberOfClusters();
-    Int_t lastTB = fTrSec[0]->GetLayerNumber(s.GetX());
-
-    //    printf("seed %d: found %d out of %d expected clusters, Min is %f\n",
-    //     i, foundClr, expectedClr, foundMin);
-
-    if (foundClr >= foundMin) {
-      if(foundClr >= 2) {
-       s.CookdEdx(); 
-       CookLabel(ps, 1-fgkLabelFraction);
-       UseClusters(ps);
-      }
-      
-      // Propagate to outer reference plane [SR, GSI, 18.02.2003]
-      ps->PropagateTo(364.8);
-      otrackTRD=ps;
-      trdTree.Fill();
-      found++;
-//      cout<<found<<'\r';
+    if (!AdjustSector(&t)) {
+      break;
     }
 
-    if(((expectedClr < 10) && (lastTB == outermostTB)) ||
-       ((expectedClr >= 10) && 
-        (((Float_t) foundClr) / ((Float_t) expectedClr) >= 
-         fgkMinFractionOfFoundClusters) && (lastTB == outermostTB))) {
-
-      Double_t xTOF = 375.5;
-    
-      if(PropagateToOuterPlane(s,xTOF)) {
-        AliTPCtrack *pt = new AliTPCtrack(*ps,ps->GetAlpha());
-        otrack = pt;
-        tofTree1.Fill();
-        delete pt;
-
-        xTOF = 381.5;
-    
-        if(PropagateToOuterPlane(s,xTOF)) {
-          AliTPCtrack *pt = new AliTPCtrack(*ps,ps->GetAlpha());
-          otrack = pt;
-          tofTree2.Fill();
-          delete pt;
-
-          Double_t xPHOS = 460.;
-          
-          if(PropagateToOuterPlane(s,xPHOS)) {
-            AliTPCtrack *pt = new AliTPCtrack(*ps,ps->GetAlpha());
-            otrack = pt;
-            phosTree.Fill();
-            delete pt;
-            
-            Double_t xRICH = 490+1.267;
-            
-            if(PropagateToOuterPlane(s,xRICH)) {
-              AliTPCtrack *pt = new AliTPCtrack(*ps,ps->GetAlpha());
-              otrack = pt;
-              richTree.Fill();
-              delete pt;
-            }   
-          }
-        }
-      }      
+    // Get material budget
+    Double_t xyz0[3];
+    Double_t xyz1[3];
+    Double_t param[7]; 
+    Double_t x;
+    Double_t y;
+    Double_t z;
+
+    // Starting global position
+    t.GetXYZ(xyz0);
+    // End global position
+    x = fTrSec[0]->GetLayer(row0)->GetX();
+    if (!t.GetProlongation(x,y,z)) {
+      break;
     }
-  }
-  
-  
-  out->cd();
-  tofTree1.Write(); 
-  tofTree2.Write(); 
-  phosTree.Write(); 
-  richTree.Write(); 
-  trdTree.Write(); 
-
-  if (IsStoringBarrel()) { // [SR, 03.04.2003]
-    fBarrelFile->cd();
-    fBarrelTree->Write();
-    fBarrelFile->Flush();
-  }
-
-  savedir->cd();  
-  cerr<<"Number of seeds: "<<nseed<<endl;  
-  cerr<<"Number of back propagated TRD tracks: "<<found<<endl;
-
-  UnloadEvent();
-
-  return 0;
-
-}
-
-//_____________________________________________________________________________
-Int_t AliTRDtracker::PropagateBack(AliESD* event) {
-  //
-  // Gets seeds from ESD event. The seeds are AliTPCtrack's found and
-  // backpropagated by the TPC tracker. Each seed is first propagated 
-  // to the TRD, and then its prolongation is searched in the TRD.
-  // If sufficiently long continuation of the track is found in the TRD
-  // the track is updated, otherwise it's stored as originaly defined 
-  // by the TPC tracker.   
-  //  
-
-  Int_t found=0;  
-  Float_t foundMin = 40;
-
-  Int_t n = event->GetNumberOfTracks();
-  for (Int_t i=0; i<n; i++) {
-    AliESDtrack* seed=event->GetTrack(i);
-    ULong_t status=seed->GetStatus();
-    if ( (status & AliESDtrack::kTPCout ) == 0 ) continue;
-    if ( (status & AliESDtrack::kTRDout) != 0 ) continue;
-
-    Int_t lbl = seed->GetLabel();
-    AliTRDtrack *track = new AliTRDtrack(*seed);
-    track->SetSeedLabel(lbl);
-    fNseeds++;
-    Float_t p4 = track->GetC();
-    //
-    Int_t expectedClr = FollowBackProlongation(*track);
-    if (track->GetNumberOfClusters()<expectedClr/3){
-      AliTRDtrack *track1 = new AliTRDtrack(*seed);
-      track1->SetSeedLabel(lbl);
-      FollowBackProlongation(*track1);
-      AliTRDtrack *track2= new AliTRDtrack(*seed);
-      track->SetSeedLabel(lbl);
-      FollowBackProlongation(*track2);      
-      delete track1;
-      delete track2;
-    }
-    if (TMath::Abs(track->GetC()-p4)/TMath::Abs(p4)>0.2) {
-      delete track;
-      continue; //too big change of curvature - to be checked
-    }
-    Int_t foundClr = track->GetNumberOfClusters();
-    if (foundClr >= foundMin) {
-      if(foundClr >= 2) {
-       track->CookdEdx(); 
-//     CookLabel(track, 1-fgkLabelFraction);
-       UseClusters(track);
+    xyz1[0] =  x * TMath::Cos(t.GetAlpha()) - y * TMath::Sin(t.GetAlpha());
+    xyz1[1] = +x * TMath::Sin(t.GetAlpha()) + y * TMath::Cos(t.GetAlpha());
+    xyz1[2] =  z;
+    AliTracker::MeanMaterialBudget(xyz0,xyz1,param);
+    xrho= param[0]*param[4];
+    xx0 = param[1]; // Get mean propagation parameters
+
+    // Flags for marking the track momentum and direction. The track is
+    // marked only if it has at least 1 cluster picked up in the current
+    // chamber.
+    Bool_t kUPDATED = kFALSE;
+    Bool_t kMARKED  = kFALSE;
+
+    // Propagate and update
+    sector = t.GetSector();
+    //for (Int_t itime=GetTimeBinsPerPlane()-1;itime>=0;itime--) {
+    for (Int_t itime = 0 ; itime < GetTimeBinsPerPlane(); itime++) {
+
+      // Mark track kinematics
+      if (itime > 10 && kUPDATED && !kMARKED) {
+       t.SetTrackSegmentDirMom(iplane);
+       kMARKED = kTRUE;
       }
-      
-      // Propagate to outer reference plane [SR, GSI, 18.02.2003]
-//      track->PropagateTo(364.8);  why?
-      
-      //seed->UpdateTrackParams(track, AliESDtrack::kTRDout);
-      //found++;
-    }
 
-    //Propagation to the TOF (I.Belikov)
-    
-    if (track->GetStop()==kFALSE){
-      
-      Double_t xtof=371.;
-      Double_t c2=track->GetC()*xtof - track->GetEta();
-      if (TMath::Abs(c2)>=0.85) continue;
-      Double_t xTOF0 = 371. ;          
-      PropagateToOuterPlane(*track,xTOF0); 
-      //      
-      Double_t ymax=xtof*TMath::Tan(0.5*AliTRDgeometry::GetAlpha());
-      Double_t y=track->GetYat(xtof);
-      if (y > ymax) {
-       if (!track->Rotate(AliTRDgeometry::GetAlpha())) {
-         delete track;
-         continue;
-       }
-      } else if (y <-ymax) {
-       if (!track->Rotate(-AliTRDgeometry::GetAlpha())) {
-         delete track;
-         continue;
-       }
+      Int_t ilayer = GetGlobalTimeBin(0,iplane,itime);
+      expectedNumberOfClusters++;
+      t.SetNExpected(t.GetNExpected() + 1);
+      if (t.GetX() > 345.0) {
+       t.SetNExpectedLast(t.GetNExpectedLast() + 1);
       }
-      
-      if (track->PropagateTo(xtof)) {
-       seed->UpdateTrackParams(track, AliESDtrack::kTRDout);    
-       if (track->GetNumberOfClusters()>foundMin) found++;
-      }
-    }else{
-      if (track->GetNumberOfClusters()>15&&track->GetNumberOfClusters()>0.5*expectedClr){
-       seed->UpdateTrackParams(track, AliESDtrack::kTRDout);
-       seed->SetStatus(AliESDtrack::kTRDStop);    
-       found++;
-      }
-    }
-
-    delete track;
-    
-    //End of propagation to the TOF
-    //if (foundClr>foundMin)
-    //  seed->UpdateTrackParams(track, AliESDtrack::kTRDout);
-    
-
-  }
-  
-  cerr<<"Number of seeds: "<<fNseeds<<endl;  
-  cerr<<"Number of back propagated TRD tracks: "<<found<<endl;
-
-  fSeeds->Clear(); fNseeds=0;
+      AliTRDpropagationLayer &timeBin = *(fTrSec[sector]->GetLayer(ilayer));
+      AliTRDcluster *cl = 0;
+      UInt_t   index   = 0;
+      Double_t maxChi2 = fgkMaxChi2;
+      x = timeBin.GetX();
 
-  return 0;
-
-}
-
-//_____________________________________________________________________________
-Int_t AliTRDtracker::RefitInward(AliESD* event)
-{
-  //
-  // Refits tracks within the TRD. The ESD event is expected to contain seeds 
-  // at the outer part of the TRD. 
-  // The tracks are propagated to the innermost time bin 
-  // of the TRD and the ESD event is updated
-  // Origin: Thomas KUHR (Thomas.Kuhr@cern.ch)
-  //
-
-  Int_t timeBins = fTrSec[0]->GetNumberOfTimeBins();
-  Float_t foundMin = fgkMinClustersInTrack * timeBins; 
-  Int_t nseed = 0;
-  Int_t found = 0;
-  Int_t innerTB = fTrSec[0]->GetInnerTimeBin();
-
-  Int_t n = event->GetNumberOfTracks();
-  for (Int_t i=0; i<n; i++) {
-    AliESDtrack* seed=event->GetTrack(i);
-    ULong_t status=seed->GetStatus();
-    if ( (status & AliESDtrack::kTRDout ) == 0 ) continue;
-    if ( (status & AliESDtrack::kTRDin) != 0 ) continue;
-    nseed++;
-
-    AliTRDtrack* seed2 = new AliTRDtrack(*seed);
-    seed2->ResetCovariance(5.); 
-    AliTRDtrack *pt = new AliTRDtrack(*seed2,seed2->GetAlpha());
-    UInt_t * indexes2 = seed2->GetIndexes();
-    UInt_t * indexes3 = pt->GetBackupIndexes();
-    for (Int_t i=0;i<200;i++) {
-      if (indexes2[i]==0) break;
-      indexes3[i] = indexes2[i];
-    }          
-    //AliTRDtrack *pt = seed2;
-    AliTRDtrack &t=*pt; 
-    FollowProlongation(t, innerTB); 
-    /*
-    if (t.GetNumberOfClusters()<seed->GetTRDclusters(indexes3)*0.5){
-      // debug  - why we dont go back?
-      AliTRDtrack *pt2 = new AliTRDtrack(*seed2,seed2->GetAlpha());
-      UInt_t * indexes2 = seed2->GetIndexes();
-      UInt_t * indexes3 = pt2->GetBackupIndexes();
-      for (Int_t i=0;i<200;i++) {
-       if (indexes2[i]==0) break;
-       indexes3[i] = indexes2[i];
-      }  
-      FollowProlongation(*pt2, innerTB);
-      delete pt2;
-    }
-    */
-    if (t.GetNumberOfClusters() >= foundMin) {
-      //      UseClusters(&t);
-      //CookLabel(pt, 1-fgkLabelFraction);
-      //      t.CookdEdx();
-    }
-    found++;
-//    cout<<found<<'\r';     
-
-    if(PropagateToTPC(t)) {
-      seed->UpdateTrackParams(pt, AliESDtrack::kTRDrefit);
-    }else{
-      //if not prolongation to TPC - propagate without update
-      AliTRDtrack* seed2 = new AliTRDtrack(*seed);
-      seed2->ResetCovariance(5.); 
-      AliTRDtrack *pt2 = new AliTRDtrack(*seed2,seed2->GetAlpha());
-      delete seed2;
-      if (PropagateToTPC(*pt2)) 
-       seed->UpdateTrackParams(pt2, AliESDtrack::kTRDrefit);
-      delete pt2;
-    }  
-
-    delete seed2;
-    delete pt;
-  }     
-
-  cout<<"Number of loaded seeds: "<<nseed<<endl;  
-  cout<<"Number of found tracks from loaded seeds: "<<found<<endl;
-
-  return 0;
-
-}
-
-
-//---------------------------------------------------------------------------
-Int_t AliTRDtracker::FollowProlongation(AliTRDtrack& t, Int_t rf)
-{
-  // Starting from current position on track=t this function tries
-  // to extrapolate the track up to timeBin=0 and to confirm prolongation
-  // if a close cluster is found. Returns the number of clusters
-  // expected to be found in sensitive layers
-
-  Float_t  wIndex, wTB, wChi2;
-  Float_t  wYrt, wYclosest, wYcorrect, wYwindow;
-  Float_t  wZrt, wZclosest, wZcorrect, wZwindow;
-  Float_t  wPx, wPy, wPz, wC;
-  Double_t px, py, pz;
-  Float_t  wSigmaC2, wSigmaTgl2, wSigmaY2, wSigmaZ2;
-  Int_t lastplane = GetLastPlane(&t);
-
-  Int_t trackIndex = t.GetLabel();  
-
-  Int_t ns=Int_t(2*TMath::Pi()/AliTRDgeometry::GetAlpha()+0.5);     
-
-  Int_t tryAgain=fMaxGap;
-
-  Double_t alpha=t.GetAlpha();
-  alpha = TVector2::Phi_0_2pi(alpha);
-
-  Int_t s=Int_t(alpha/AliTRDgeometry::GetAlpha())%AliTRDgeometry::kNsect;  
-  Double_t radLength, rho, x, dx, y, ymax, z;
-
-  Int_t expectedNumberOfClusters = 0;
-  Bool_t lookForCluster;
-
-  alpha=AliTRDgeometry::GetAlpha();  // note: change in meaning
-
-  for (Int_t nr=fTrSec[0]->GetLayerNumber(t.GetX()); nr>rf; nr--) { 
-
-    y = t.GetY(); z = t.GetZ();
-
-    // first propagate to the inner surface of the current time bin 
-    fTrSec[s]->GetLayer(nr)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr)->GetX()-dx/2; y = t.GetY(); z = t.GetZ();
-    if(!t.PropagateTo(x,radLength,rho)) break;
-    y = t.GetY();
-    ymax = x*TMath::Tan(0.5*alpha);
-    if (y > ymax) {
-      s = (s+1) % ns;
-      if (!t.Rotate(alpha)) break;
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    } else if (y <-ymax) {
-      s = (s-1+ns) % ns;                           
-      if (!t.Rotate(-alpha)) break;   
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    } 
-
-    y = t.GetY(); z = t.GetZ();
-
-    // now propagate to the middle plane of the next time bin 
-    fTrSec[s]->GetLayer(nr-1)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr-1)->GetX(); y = t.GetY(); z = t.GetZ();
-    if(!t.PropagateTo(x,radLength,rho)) break;
-    y = t.GetY();
-    ymax = x*TMath::Tan(0.5*alpha);
-    if (y > ymax) {
-      s = (s+1) % ns;
-      if (!t.Rotate(alpha)) break;
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    } else if (y <-ymax) {
-      s = (s-1+ns) % ns;                           
-      if (!t.Rotate(-alpha)) break;   
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    } 
-
-
-    if(lookForCluster) {
-
-      expectedNumberOfClusters++;       
-      wIndex = (Float_t) t.GetLabel();
-      wTB = nr;
-
-      AliTRDpropagationLayer& timeBin=*(fTrSec[s]->GetLayer(nr-1));
-
-      Double_t sy2=ExpectedSigmaY2(x,t.GetTgl(),t.GetPt());
-      Double_t sz2=ExpectedSigmaZ2(x,t.GetTgl());
-
-      Double_t road;
-      if((t.GetSigmaY2() + sy2) > 0) road=10.*sqrt(t.GetSigmaY2() + sy2);
-      else return expectedNumberOfClusters;
-      
-      wYrt = (Float_t) y;
-      wZrt = (Float_t) z;
-      wYwindow = (Float_t) road;
-      t.GetPxPyPz(px,py,pz);
-      wPx = (Float_t) px;
-      wPy = (Float_t) py;
-      wPz = (Float_t) pz;
-      wC  = (Float_t) t.GetC();
-      wSigmaC2 = (Float_t) t.GetSigmaC2();
-      wSigmaTgl2    = (Float_t) t.GetSigmaTgl2();
-      wSigmaY2 = (Float_t) t.GetSigmaY2();
-      wSigmaZ2 = (Float_t) t.GetSigmaZ2();
-      wChi2 = -1;            
-      
-
-      AliTRDcluster *cl=0;
-      UInt_t index=0;
-
-      Double_t maxChi2=fgkMaxChi2;
-
-      wYclosest = 12345678;
-      wYcorrect = 12345678;
-      wZclosest = 12345678;
-      wZcorrect = 12345678;
-      wZwindow  = TMath::Sqrt(2.25 * 12 * sz2);   
-
-      // Find the closest correct cluster for debugging purposes
       if (timeBin) {
-        Float_t minDY = 1000000;
-        for (Int_t i=0; i<timeBin; i++) {
-          AliTRDcluster* c=(AliTRDcluster*)(timeBin[i]);
-          if((c->GetLabel(0) != trackIndex) &&
-             (c->GetLabel(1) != trackIndex) &&
-             (c->GetLabel(2) != trackIndex)) continue;
-          if(TMath::Abs(c->GetY() - y) > minDY) continue;
-          minDY = TMath::Abs(c->GetY() - y);
-          wYcorrect = c->GetY();
-          wZcorrect = c->GetZ();
-
-          Double_t h01 = GetTiltFactor(c);
-          wChi2 = t.GetPredictedChi2(c, h01);
-        }
-      }                    
-
-      // Now go for the real cluster search
 
-      if (timeBin) {
-       //
-       //find cluster in history
-       cl =0;
-       
-       AliTRDcluster * cl0 = timeBin[0];
+       AliTRDcluster *cl0 = timeBin[0];
        if (!cl0) {
+         // No clusters in given time bin
+         continue;
+       }
+
+        Int_t layer = fGeom->GetLayer(cl0->GetDetector());
+       if (layer > lastplane) {
          continue;
        }
-       Int_t plane = fGeom->GetPlane(cl0->GetDetector());
-       if (plane>lastplane) continue;
+
        Int_t timebin = cl0->GetLocalTimeBin();
-       AliTRDcluster * cl2= GetCluster(&t,plane, timebin);
+       AliTRDcluster *cl2 = GetCluster(&t,layer,timebin,index);
+
        if (cl2) {
-         cl =cl2;      
-         Double_t h01 = GetTiltFactor(cl);
-         maxChi2=t.GetPredictedChi2(cl,h01);
-       }
-       if ((!cl) && road>fgkWideRoad) {
-         //if (t.GetNumberOfClusters()>4)
-         //  cerr<<t.GetNumberOfClusters()
-         //    <<"FindProlongation warning: Too broad road !\n";
-         continue;
-       }             
-
-
-       if(!cl){
-
-         for (Int_t i=timeBin.Find(y-road); i<timeBin; i++) {
-           AliTRDcluster* c=(AliTRDcluster*)(timeBin[i]);
-           if (c->GetY() > y+road) break;
-           if (c->IsUsed() > 0) continue;
-           if((c->GetZ()-z)*(c->GetZ()-z) > 3 * sz2) continue;
-           
-           Double_t h01 = GetTiltFactor(c);
-           Double_t chi2=t.GetPredictedChi2(c,h01);
-           
-           if (chi2 > maxChi2) continue;
-           maxChi2=chi2;
-           cl=c;
-           index=timeBin.GetIndex(i);
-         }               
+         cl = cl2;
+         //Double_t h01 = GetTiltFactor(cl);    //I.B's fix
+         //maxChi2=t.GetPredictedChi2(cl,h01);
        }
 
-        if(!cl) {
-
-          for (Int_t i=timeBin.Find(y-road); i<timeBin; i++) {
-            AliTRDcluster* c=(AliTRDcluster*)(timeBin[i]);
-            
-            if (c->GetY() > y+road) break;
-            if (c->IsUsed() > 0) continue;
-            if((c->GetZ()-z)*(c->GetZ()-z) > 12 * sz2) continue;
-            
-            Double_t h01 = GetTiltFactor(c);
-            Double_t chi2=t.GetPredictedChi2(c, h01);
-            
-            if (chi2 > maxChi2) continue;
-            maxChi2=chi2;
-            cl=c;
-            index=timeBin.GetIndex(i);
-          }
-        }        
-        if (cl) {
-          wYclosest = cl->GetY();
-          wZclosest = cl->GetZ();
-          Double_t h01 = GetTiltFactor(cl);
-
-          t.SetSampledEdx(cl->GetQ()/dx,t.GetNumberOfClusters()); 
-         //printf("Track   position\t%f\t%f\t%f\n",t.GetX(),t.GetY(),t.GetZ());
-         //printf("Cluster position\t%d\t%f\t%f\n",cl->GetLocalTimeBin(),cl->GetY(),cl->GetZ());
-         Int_t det = cl->GetDetector();    
-         Int_t plane = fGeom->GetPlane(det);
-
-         if(!t.UpdateMI(cl,maxChi2,index,h01,plane)) {
-           //if(!t.Update(cl,maxChi2,index,h01)) {
-            //if(!tryAgain--) return 0;
-          }  
-          else tryAgain=fMaxGap;
-        }
-        else {
-          //if (tryAgain==0) break; 
-          tryAgain--;
-        }
+       if (cl) {
+
+         //if (cl->GetNPads()<5)
+         Double_t dxsample = timeBin.GetdX();
+         t.SetSampledEdx(TMath::Abs(cl->GetQ()/dxsample));
+         Double_t h01      = GetTiltFactor(cl);
+         Int_t    det      = cl->GetDetector();
+         Int_t    llayer   = fGeom->GetLayer(det);
+
+         if (t.GetX() > 345.0) {
+           t.SetNLast(t.GetNLast() + 1);
+           t.SetChi2Last(t.GetChi2Last() + maxChi2);
+         }
+
+         Double_t xcluster = cl->GetX();
+         t.PropagateTo(xcluster,xx0,xrho);                     
+         if (!AdjustSector(&t)) {
+           break;           //I.B's fix
+         }
+
+         maxChi2 = t.GetPredictedChi2(cl,h01);                                 
+         if (maxChi2 < 1e+10) {
+           if (!t.UpdateMI(cl,maxChi2,index,h01,llayer)) {
+             // ????
+           } 
+            else {
+             //SetCluster(cl, GetNumberOfClusters()-1);
+             kUPDATED = kTRUE;
+           }
+         }
+
+       }
 
-        /*
-        if((((Int_t) wTB)%15 == 0) || (((Int_t) wTB)%15 == 14)) {
-          
-          printf(" %f", wIndex);       //1
-          printf(" %f", wTB);          //2
-          printf(" %f", wYrt);         //3
-          printf(" %f", wYclosest);    //4
-          printf(" %f", wYcorrect);    //5
-          printf(" %f", wYwindow);     //6
-          printf(" %f", wZrt);         //7
-          printf(" %f", wZclosest);    //8
-          printf(" %f", wZcorrect);    //9
-          printf(" %f", wZwindow);     //10
-          printf(" %f", wPx);          //11
-          printf(" %f", wPy);          //12
-          printf(" %f", wPz);          //13
-          printf(" %f", wSigmaC2*1000000);  //14
-          printf(" %f", wSigmaTgl2*1000);   //15
-          printf(" %f", wSigmaY2);     //16
-          //      printf(" %f", wSigmaZ2);     //17
-          printf(" %f", wChi2);     //17
-          printf(" %f", wC);           //18
-          printf("\n");
-        } 
-        */                        
       }
-    }  
+
+    }
+
   }
+
   return expectedNumberOfClusters;
-  
-  
-}                
 
-//___________________________________________________________________
+}                
 
-Int_t AliTRDtracker::FollowBackProlongation(AliTRDtrack& t)
+//_____________________________________________________________________________
+Int_t AliTRDtracker::FollowBackProlongation(AliTRDtrack &t)
 {
+  //  
   // Starting from current radial position of track <t> this function
-  // extrapolates the track up to outer timebin and in the sensitive
+  // extrapolates the track up to the outer timebin and in the sensitive
   // layers confirms prolongation if a close cluster is found. 
   // Returns the number of clusters expected to be found in sensitive layers
+  // Uses the geomanager for material description
+  //
+  // return number of assigned clusters ? 
+  //
 
-  Float_t  wIndex, wTB, wChi2;
-  Float_t  wYrt, wYclosest, wYcorrect, wYwindow;
-  Float_t  wZrt, wZclosest, wZcorrect, wZwindow;
-  Float_t  wPx, wPy, wPz, wC;
-  Double_t px, py, pz;
-  Float_t  wSigmaC2, wSigmaTgl2, wSigmaY2, wSigmaZ2;
-
-  Int_t trackIndex = t.GetLabel();  
-  Int_t tryAgain=fMaxGap;
+  Int_t    sector;
 
-  Double_t alpha=t.GetAlpha();
-  TVector2::Phi_0_2pi(alpha);
+  Double_t xx0    = 0.0;
+  Double_t xrho   = 0.0;
 
-  Int_t s;
+  Float_t  ratio0 = 0.0;
 
-  Int_t outerTB = fTrSec[0]->GetOuterTimeBin();
-  Double_t radLength, rho, x, dx, y, ymax = 0, z;
-  Bool_t lookForCluster;
+  Int_t    expectedNumberOfClusters = 0;
 
-  Int_t expectedNumberOfClusters = 0;
-  x = t.GetX();
+  AliTRDtracklet tracklet;
 
-  alpha=AliTRDgeometry::GetAlpha();  // note: change in meaning
+  const Int_t kNclusters = 1000;
+  Int_t       clusters[kNclusters];
+  for (Int_t i = 0; i < kNclusters; i++) {
+    clusters[i] = -1;
+  }
 
-  Int_t nRefPlane = fgkFirstPlane;
-  Bool_t isNewLayer = kFALSE; 
+//   // Calibration fill 2D
+//   AliTRDCalibraFillHisto *calibra = AliTRDCalibraFillHisto::Instance();
+//   if (!calibra) {
+//     AliInfo("Could not get Calibra instance\n");
+//   }
+//   if (calibra->GetMITracking()) {
+//     calibra->ResetTrack();
+//   }
 
-  Double_t chi2;
-  Double_t minDY;
-  Int_t zone =-10;
-  Int_t nr;
-  for (nr=fTrSec[0]->GetLayerNumber(t.GetX()); nr<outerTB+1; nr++) { 
-    
-    y = t.GetY(); 
-    z = t.GetZ();
+  // Loop through the TRD planes
+  for (Int_t iplane = 0; iplane < AliTRDtrack::kNplane; iplane++) {
 
-    // first propagate to the outer surface of the current time bin 
+    Int_t hb = iplane * 10;
+    fHClSearch->Fill(hb);
 
-    s = t.GetSector();
-    fTrSec[s]->GetLayer(nr)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr)->GetX()+dx/2; 
-    y = t.GetY(); 
-    z = t.GetZ();
+    // Get the global time bin numbers for the first an last 
+    // local time bin of the given plane
+    Int_t    row0     = GetGlobalTimeBin(0,iplane,GetTimeBinsPerPlane()-1);
+    Int_t    rowlast  = GetGlobalTimeBin(0,iplane,0);
 
-    if(!t.PropagateTo(x,radLength,rho)) break;
-    //    if (!AdjustSector(&t)) break;
-    //
-    // MI -fix untill correct material desription will be implemented
-    //
-    Float_t angle =  t.GetAlpha();  // MI - if rotation - we go through the material - 
-    if (!AdjustSector(&t)) break;
-    if (TMath::Abs(angle -  t.GetAlpha())>0.000001) break; //better to stop track
-    Int_t currentzone = fTrSec[s]->GetLayer(nr)->GetZone(z);
-    if (currentzone==-10) break;  // we are in the frame
-    if (currentzone>-10){   // layer knows where we are
-      if (zone==-10) zone = currentzone;
-      if (zone!=currentzone) break;  
+    // Get the X coordinates of the propagation layer for the first time bin
+    Double_t currentx = fTrSec[0]->GetLayer(row0)->GetX();
+    if (currentx < t.GetX()) {
+      fHClSearch->Fill(hb+1);
+      continue;
     }
-    //
-    //
-    s = t.GetSector();
-    if (!t.PropagateTo(x,radLength,rho)) break;
-
-    y = t.GetY();
-    z = t.GetZ();
-
-    // Barrel Tracks [SR, 04.04.2003]
 
-    s = t.GetSector();
-    if (fTrSec[s]->GetLayer(nr)->IsSensitive() != 
-        fTrSec[s]->GetLayer(nr+1)->IsSensitive() ) {
-
-//      if (IsStoringBarrel()) StoreBarrelTrack(&t, nRefPlane++, kTrackBack);
+    // Propagate closer to the current chamber if neccessary 
+    if (currentx > (fgkMaxStep + t.GetX())) {
+      if (!PropagateToX(t,currentx-fgkMaxStep,fgkMaxStep)) {
+       fHClSearch->Fill(hb+2);
+        break;
+      }
     }
 
-    if (fTrSec[s]->GetLayer(nr-1)->IsSensitive() && 
-          ! fTrSec[s]->GetLayer(nr)->IsSensitive()) {
-      isNewLayer = kTRUE;
-    } else {isNewLayer = kFALSE;}
-
-    y = t.GetY();
-    z = t.GetZ();
-
-    // now propagate to the middle plane of the next time bin 
-    fTrSec[s]->GetLayer(nr+1)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-
-    x = fTrSec[s]->GetLayer(nr+1)->GetX(); 
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    if (!AdjustSector(&t)) break;
-    s = t.GetSector();
-      if(!t.PropagateTo(x,radLength,rho)) break;
+    // Rotate track to adjacent sector if neccessary
+    if (!AdjustSector(&t)) {
+      fHClSearch->Fill(hb+3);
+      break;
+    }
 
-    y = t.GetY();
-    z = t.GetZ();
+    // Check whether azimuthal angle is getting too large
+    if (TMath::Abs(t.GetSnp()) > fgkMaxSnp) {
+      fHClSearch->Fill(hb+4);
+      break;
+    }
 
-    if(fVocal) printf("nr+1=%d, x %f, z %f, y %f, ymax %f\n",nr+1,x,z,y,ymax);
-    //    printf("label %d, pl %d, lookForCluster %d \n",
-    //     trackIndex, nr+1, lookForCluster);
+    Double_t xyz0[3];
+    Double_t xyz1[3];
+    Double_t param[7];
+    Double_t x;
+    Double_t y;
+    Double_t z;
+    // Global start position (beginning of chamber)
+    t.GetXYZ(xyz0);   
+    // X-position of the end of the chamber
+    x = fTrSec[0]->GetLayer(rowlast)->GetX();
+    // Get local Y and Z at the X-position of the end of the chamber
+    if (!t.GetProlongation(x,y,z)) {
+      fHClSearch->Fill(hb+5);
+      break;
+    }
+    // Global end position (end of chamber)
+    xyz1[0] =  x * TMath::Cos(t.GetAlpha()) - y * TMath::Sin(t.GetAlpha()); 
+    xyz1[1] = +x * TMath::Sin(t.GetAlpha()) + y * TMath::Cos(t.GetAlpha());
+    xyz1[2] =  z;
+
+    // Calculate the mean material budget along the path inside the chamber
+    AliTracker::MeanMaterialBudget(xyz0,xyz1,param);   
+    // The mean propagation parameters (density*length and radiation length)
+    xrho = param[0]*param[4];
+    xx0  = param[1]; 
+
+    // Find the clusters and tracklet along the path inside the chamber
+    sector      = t.GetSector();
+    Float_t ncl = FindClusters(sector,row0,rowlast,&t,clusters,tracklet);
+    fHNCl->Fill(tracklet.GetN());
+
+    // Discard if in less than 1/3 of the available timebins 
+    // clusters are found 
+    if (tracklet.GetN() < GetTimeBinsPerPlane()/3) {
+      fHClSearch->Fill(hb+6);
+      continue;
+    }
 
-    if(lookForCluster) {
+    //
+    // Propagate and update track
+    //
+    for (Int_t itime = GetTimeBinsPerPlane()-1; itime >= 0; itime--) {
+      Int_t ilayer = GetGlobalTimeBin(0, iplane,itime);
       expectedNumberOfClusters++;       
-
-      wIndex = (Float_t) t.GetLabel();
-      wTB = fTrSec[s]->GetLayer(nr+1)->GetTimeBinIndex();
-
-      AliTRDpropagationLayer& timeBin=*(fTrSec[s]->GetLayer(nr+1));
-      Double_t sy2=ExpectedSigmaY2(t.GetX(),t.GetTgl(),t.GetPt());
-      Double_t sz2=ExpectedSigmaZ2(t.GetX(),t.GetTgl());
-      if((t.GetSigmaY2() + sy2) < 0) break;
-      Double_t road = 10.*sqrt(t.GetSigmaY2() + sy2); 
-      Double_t y=t.GetY(), z=t.GetZ();
-
-      wYrt = (Float_t) y;
-      wZrt = (Float_t) z;
-      wYwindow = (Float_t) road;
-      t.GetPxPyPz(px,py,pz);
-      wPx = (Float_t) px;
-      wPy = (Float_t) py;
-      wPz = (Float_t) pz;
-      wC  = (Float_t) t.GetC();
-      wSigmaC2 = (Float_t) t.GetSigmaC2();
-      wSigmaTgl2    = (Float_t) t.GetSigmaTgl2();
-      wSigmaY2 = (Float_t) t.GetSigmaY2();
-      wSigmaZ2 = (Float_t) t.GetSigmaZ2();
-      wChi2 = -1;            
-      
-      if (road>fgkWideRoad) {
-        if (t.GetNumberOfClusters()>4)
-          cerr<<t.GetNumberOfClusters()
-              <<"FindProlongation warning: Too broad road !\n";
-        return 0;
-      }      
-
-      AliTRDcluster *cl=0;
-      UInt_t index=0;
-
-      Double_t maxChi2=fgkMaxChi2;
-
-      if (isNewLayer) { 
-        road = 3 * road;
-        //sz2 = 3 * sz2;
-        maxChi2 = 10 * fgkMaxChi2;
+      t.SetNExpected(t.GetNExpected() + 1);
+      if (t.GetX() > 345.0) {
+        t.SetNExpectedLast(t.GetNExpectedLast() + 1);
       }
-      
-      if (nRefPlane == fgkFirstPlane) maxChi2 = 20 * fgkMaxChi2; 
-      if (nRefPlane == fgkFirstPlane+2) maxChi2 = 15 * fgkMaxChi2;
-      if (t.GetNRotate() > 0) maxChi2 = 3 * maxChi2;
-      
-
-      wYclosest = 12345678;
-      wYcorrect = 12345678;
-      wZclosest = 12345678;
-      wZcorrect = 12345678;
-      wZwindow  = TMath::Sqrt(2.25 * 12 * sz2);   
-
-      // Find the closest correct cluster for debugging purposes
-      if (timeBin) {
-        minDY = 1000000;
-        for (Int_t i=0; i<timeBin; i++) {
-          AliTRDcluster* c=(AliTRDcluster*)(timeBin[i]);
-          if((c->GetLabel(0) != trackIndex) &&
-             (c->GetLabel(1) != trackIndex) &&
-             (c->GetLabel(2) != trackIndex)) continue;
-          if(TMath::Abs(c->GetY() - y) > minDY) continue;
-          //minDY = TMath::Abs(c->GetY() - y);
-          minDY = c->GetY() - y;
-          wYcorrect = c->GetY();
-          wZcorrect = c->GetZ();
-
-          Double_t h01 = GetTiltFactor(c);
-          wChi2 = t.GetPredictedChi2(c, h01);
-        }
-      }                    
-
-      // Now go for the real cluster search
-
-      if (timeBin) {
-
-        for (Int_t i=timeBin.Find(y-road); i<timeBin; i++) {
-          AliTRDcluster* c=(AliTRDcluster*)(timeBin[i]);
-          if (c->GetY() > y+road) break;
-          if (c->IsUsed() > 0) continue;
-          if((c->GetZ()-z)*(c->GetZ()-z) > 3 * sz2) continue;
-
-          Double_t h01 = GetTiltFactor(c);
-          chi2=t.GetPredictedChi2(c,h01);
-          
-          if (chi2 > maxChi2) continue;
-          maxChi2=chi2;
-          cl=c;
-          index=timeBin.GetIndex(i);
-
-          //check is correct
-          if((c->GetLabel(0) != trackIndex) &&
-             (c->GetLabel(1) != trackIndex) &&
-             (c->GetLabel(2) != trackIndex)) t.AddNWrong();
-        }               
+      AliTRDpropagationLayer &timeBin = *(fTrSec[sector]->GetLayer(ilayer));
+      AliTRDcluster *cl = 0;
+      UInt_t   index   = 0;
+      Double_t maxChi2 = fgkMaxChi2;
+      x = timeBin.GetX();
+
+      if (timeBin) {   
+                               if (clusters[ilayer] > 0) {
+                                       index = clusters[ilayer];
+                                       cl    = (AliTRDcluster *)GetCluster(index);
+                                       //Double_t h01 = GetTiltFactor(cl);   // I.B's fix
+                                                               //maxChi2=t.GetPredictedChi2(cl,h01); //
+                               }
        
-        if(!cl) {
-
-          for (Int_t i=timeBin.Find(y-road); i<timeBin; i++) {
-            AliTRDcluster* c=(AliTRDcluster*)(timeBin[i]);
-            
-            if (c->GetY() > y+road) break;
-            if (c->IsUsed() > 0) continue;
-            if((c->GetZ()-z)*(c->GetZ()-z) > 2.25 * 12 * sz2) continue;
-            
-            Double_t h01 = GetTiltFactor(c);
-            chi2=t.GetPredictedChi2(c,h01);
-            
-            if (chi2 > maxChi2) continue;
-            maxChi2=chi2;
-            cl=c;
-            index=timeBin.GetIndex(i);
-          }
-        }        
-        
         if (cl) {
-          wYclosest = cl->GetY();
-          wZclosest = cl->GetZ();
-
-          t.SetSampledEdx(cl->GetQ()/dx,t.GetNumberOfClusters()); 
-          Double_t h01 = GetTiltFactor(cl);
-         Int_t det = cl->GetDetector();    
-         Int_t plane = fGeom->GetPlane(det);
-
-         if(!t.UpdateMI(cl,maxChi2,index,h01,plane)) {
-          //if(!t.Update(cl,maxChi2,index,h01)) {
-            if(!tryAgain--) return 0;
-          }  
-          else tryAgain=fMaxGap;
-        }
-        else {
-          if (tryAgain==0) break; 
-          tryAgain--;
-          
-          //if (minDY < 1000000 && isNewLayer) 
-            //cout << "\t" << nRefPlane << "\t" << "\t" << t.GetNRotate() <<  "\t" << 
-            //  road << "\t" << minDY << "\t" << chi2 << "\t" << wChi2 << "\t" << maxChi2 << endl;
-                                                                     
-        }
-
-        isNewLayer = kFALSE;
-
-        /*
-        if((((Int_t) wTB)%15 == 0) || (((Int_t) wTB)%15 == 14)) {
-          
-          printf(" %f", wIndex);       //1
-          printf(" %f", wTB);          //2
-          printf(" %f", wYrt);         //3
-          printf(" %f", wYclosest);    //4
-          printf(" %f", wYcorrect);    //5
-          printf(" %f", wYwindow);     //6
-          printf(" %f", wZrt);         //7
-          printf(" %f", wZclosest);    //8
-          printf(" %f", wZcorrect);    //9
-          printf(" %f", wZwindow);     //10
-          printf(" %f", wPx);          //11
-          printf(" %f", wPy);          //12
-          printf(" %f", wPz);          //13
-          printf(" %f", wSigmaC2*1000000);  //14
-          printf(" %f", wSigmaTgl2*1000);   //15
-          printf(" %f", wSigmaY2);     //16
-          //      printf(" %f", wSigmaZ2);     //17
-          printf(" %f", wChi2);     //17
-          printf(" %f", wC);           //18
-          printf("\n");
-        } 
-        */                        
-      }
-    }  
-  }
-  if (nr<outerTB) 
-    t.SetStop(kTRUE);
-  else
-    t.SetStop(kFALSE);
-  return expectedNumberOfClusters;
-
-
-}         
-
-//---------------------------------------------------------------------------
-Int_t AliTRDtracker::Refit(AliTRDtrack& t, Int_t rf)
-{
-  // Starting from current position on track=t this function tries
-  // to extrapolate the track up to timeBin=0 and to reuse already
-  // assigned clusters. Returns the number of clusters
-  // expected to be found in sensitive layers
-  // get indices of assigned clusters for each layer
-  // Origin: Thomas KUHR (Thomas.Kuhr@cern.ch)
-
-  Int_t iCluster[90];
-  for (Int_t i = 0; i < 90; i++) iCluster[i] = 0;
-  for (Int_t i = 0; i < t.GetNumberOfClusters(); i++) {
-    Int_t index = t.GetClusterIndex(i);
-    AliTRDcluster *cl=(AliTRDcluster*) GetCluster(index);
-    if (!cl) continue;
-    Int_t detector=cl->GetDetector();
-    Int_t localTimeBin=cl->GetLocalTimeBin();
-    Int_t sector=fGeom->GetSector(detector);
-    Int_t plane=fGeom->GetPlane(detector);
-
-    Int_t trackingSector = CookSectorIndex(sector);
-
-    Int_t gtb = fTrSec[trackingSector]->CookTimeBinIndex(plane,localTimeBin);
-    if(gtb < 0) continue; 
-    Int_t layer = fTrSec[trackingSector]->GetLayerNumber(gtb);
-    iCluster[layer] = index;
-  }
-  t.ResetClusters();
-
-  Int_t ns=Int_t(2*TMath::Pi()/AliTRDgeometry::GetAlpha()+0.5);     
+                                       //if (cl->GetNPads() < 5)
+                                       Double_t dxsample = timeBin.GetdX();
+                                       t.SetSampledEdx(TMath::Abs(cl->GetQ()/dxsample));
+                                                               Double_t h01      = GetTiltFactor(cl);
+                                       Int_t    det      = cl->GetDetector();
+                                       Int_t    layer    = fGeom->GetLayer(det);
+                                       if (t.GetX() > 345.0) {
+                                               t.SetNLast(t.GetNLast() + 1);
+                                               t.SetChi2Last(t.GetChi2Last() + maxChi2);
+                                       }
+                                       Double_t xcluster = cl->GetX();
+                                       t.PropagateTo(xcluster,xx0,xrho);
+                                       maxChi2 = t.GetPredictedChi2(cl,h01);
+
+                                       if (maxChi2<1e+10)
+                                               if (!t.UpdateMI(cl,maxChi2,index,h01,layer)) {
+                                                       if (!t.Update(cl,maxChi2,index,h01)) {
+                                       // ????
+                                                       }
+                                               } // else SetCluster(cl, GetNumberOfClusters()-1); // A.Bercuci 25.07.07
+  
 
-  Double_t alpha=t.GetAlpha();
-  alpha = TVector2::Phi_0_2pi(alpha);
+//           if (calibra->GetMITracking()) {
+//             calibra->UpdateHistograms(cl,&t);
+//           }
 
-  Int_t s=Int_t(alpha/AliTRDgeometry::GetAlpha())%AliTRDgeometry::kNsect;  
-  Double_t radLength, rho, x, dx, y, ymax, z;
+                                       // Reset material budget if 2 consecutive gold
+                                       if (layer > 0) {
+                                               if ((t.GetTracklets(layer).GetN() + t.GetTracklets(layer-1).GetN()) > 20) {
+                                                       t.SetBudget(2,0.0);
+                                               }
+                                       }
+                       
+                               }
 
-  Int_t expectedNumberOfClusters = 0;
-  Bool_t lookForCluster;
+      }
 
-  alpha=AliTRDgeometry::GetAlpha();  // note: change in meaning
+    }
 
-  for (Int_t nr=fTrSec[0]->GetLayerNumber(t.GetX()); nr>rf; nr--) { 
-
-    y = t.GetY(); z = t.GetZ();
-
-    // first propagate to the inner surface of the current time bin 
-    fTrSec[s]->GetLayer(nr)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr)->GetX()-dx/2; y = t.GetY(); z = t.GetZ();
-    if(!t.PropagateTo(x,radLength,rho)) break;
-    y = t.GetY();
-    ymax = x*TMath::Tan(0.5*alpha);
-    if (y > ymax) {
-      s = (s+1) % ns;
-      if (!t.Rotate(alpha)) break;
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    } else if (y <-ymax) {
-      s = (s-1+ns) % ns;                           
-      if (!t.Rotate(-alpha)) break;   
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    } 
-
-    y = t.GetY(); z = t.GetZ();
-
-    // now propagate to the middle plane of the next time bin 
-    fTrSec[s]->GetLayer(nr-1)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr-1)->GetX(); y = t.GetY(); z = t.GetZ();
-    if(!t.PropagateTo(x,radLength,rho)) break;
-    y = t.GetY();
-    ymax = x*TMath::Tan(0.5*alpha);
-    if (y > ymax) {
-      s = (s+1) % ns;
-      if (!t.Rotate(alpha)) break;
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    } else if (y <-ymax) {
-      s = (s-1+ns) % ns;                           
-      if (!t.Rotate(-alpha)) break;   
-      if(!t.PropagateTo(x,radLength,rho)) break;
-    } 
-
-    if(lookForCluster) expectedNumberOfClusters++;       
-
-    // use assigned cluster
-    if (!iCluster[nr-1]) continue;
-    AliTRDcluster *cl=(AliTRDcluster*)GetCluster(iCluster[nr-1]);
-    Double_t h01 = GetTiltFactor(cl);
-    Double_t chi2=t.GetPredictedChi2(cl, h01);
-    t.SetSampledEdx(cl->GetQ()/dx,t.GetNumberOfClusters()); 
-    t.Update(cl,chi2,iCluster[nr-1],h01);
+    ratio0 = ncl / Float_t(fTimeBinsPerPlane);
+    Float_t ratio1 = Float_t(t.GetNumberOfClusters()+1) / Float_t(t.GetNExpected()+1); 
+    if ((tracklet.GetChi2()      <  18.0) && 
+        (ratio0                  >   0.8) && 
+        (ratio1                  >   0.6) && 
+        (ratio0+ratio1           >   1.5) && 
+        (t.GetNCross()           ==    0) && 
+        (TMath::Abs(t.GetSnp())  <  0.85) &&
+        (t.GetNumberOfClusters() >    20)){
+      //if (ratio0 > 0.8) {
+      t.MakeBackupTrack(); // Make backup of the track until is gold
+    }
+    
   }
 
-  return expectedNumberOfClusters;
-}                
+  return expectedNumberOfClusters;  
 
-//___________________________________________________________________
+}         
 
-Int_t AliTRDtracker::PropagateToOuterPlane(AliTRDtrack& t, Double_t xToGo)
+//_____________________________________________________________________________
+Int_t AliTRDtracker::PropagateToX(AliTRDtrack &t, Double_t xToGo, Double_t maxStep)
 {
-  // Starting from current radial position of track <t> this function
+  //
+  // Starting from current X-position of track <t> this function
   // extrapolates the track up to radial position <xToGo>. 
   // Returns 1 if track reaches the plane, and 0 otherwise 
+  //
 
-  Int_t ns=Int_t(2*TMath::Pi()/AliTRDgeometry::GetAlpha()+0.5);     
-
-  Double_t alpha=t.GetAlpha();
-
-  if (alpha > 2.*TMath::Pi()) alpha -= 2.*TMath::Pi();
-  if (alpha < 0.            ) alpha += 2.*TMath::Pi();
-
-  Int_t s=Int_t(alpha/AliTRDgeometry::GetAlpha())%AliTRDgeometry::kNsect;  
-
-  Bool_t lookForCluster;
-  Double_t radLength, rho, x, dx, y, ymax, z;
-
-  x = t.GetX();
-
-  alpha=AliTRDgeometry::GetAlpha();  // note: change in meaning
-
-  Int_t plToGo = fTrSec[0]->GetLayerNumber(xToGo);
-
-  for (Int_t nr=fTrSec[0]->GetLayerNumber(x); nr<plToGo; nr++) { 
-
-    y = t.GetY(); z = t.GetZ();
-
-    // first propagate to the outer surface of the current time bin 
-    fTrSec[s]->GetLayer(nr)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr)->GetX()+dx/2; y = t.GetY(); z = t.GetZ();
-    if(!t.PropagateTo(x,radLength,rho)) return 0;
-    y = t.GetY();
-    ymax = x*TMath::Tan(0.5*alpha);
-    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;   
-    } 
-    if(!t.PropagateTo(x,radLength,rho)) return 0;
-
-    y = t.GetY(); z = t.GetZ();
+  const Double_t kEpsilon = 0.00001;
 
-    // now propagate to the middle plane of the next time bin 
-    fTrSec[s]->GetLayer(nr+1)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr+1)->GetX(); y = t.GetY(); z = t.GetZ();
-    if(!t.PropagateTo(x,radLength,rho)) return 0;
-    y = t.GetY();
-    ymax = x*TMath::Tan(0.5*alpha);
-    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;   
-    } 
-    if(!t.PropagateTo(x,radLength,rho)) return 0;
-  }
-  return 1;
-}         
+  // Current track X-position
+  Double_t xpos = t.GetX();
 
-//___________________________________________________________________
+  // Direction: inward or outward
+  Double_t dir  = (xpos < xToGo) ? 1.0 : -1.0;
 
-Int_t AliTRDtracker::PropagateToTPC(AliTRDtrack& t)
-{
-  // Starting from current radial position of track <t> this function
-  // extrapolates the track up to radial position of the outermost
-  // padrow of the TPC. 
-  // Returns 1 if track reaches the TPC, and 0 otherwise 
+  while (((xToGo - xpos) * dir) > kEpsilon) {
 
-  //Int_t ns=Int_t(2*TMath::Pi()/AliTRDgeometry::GetAlpha()+0.5);     
+    Double_t xyz0[3];
+    Double_t xyz1[3];
+    Double_t param[7];
+    Double_t x;
+    Double_t y;
+    Double_t z;
 
-  Double_t alpha=t.GetAlpha();
-  alpha = TVector2::Phi_0_2pi(alpha);
+    // The next step size
+    Double_t step = dir * TMath::Min(TMath::Abs(xToGo-xpos),maxStep);
 
-  Int_t s=Int_t(alpha/AliTRDgeometry::GetAlpha())%AliTRDgeometry::kNsect;  
+    // Get the global position of the starting point
+    t.GetXYZ(xyz0);
 
-  Bool_t lookForCluster;
-  Double_t radLength, rho, x, dx, y, /*ymax,*/ z;
+    // X-position after next step
+    x = xpos + step;
 
-  x = t.GetX();
+    // Get local Y and Z at the X-position of the next step
+    if (!t.GetProlongation(x,y,z)) {
+      return 0; // No prolongation possible
+    }
 
-  alpha=AliTRDgeometry::GetAlpha();  // note: change in meaning
-  Int_t plTPC = fTrSec[0]->GetLayerNumber(246.055);
+    // The global position of the end point of this prolongation step
+    xyz1[0] =  x * TMath::Cos(t.GetAlpha()) - y * TMath::Sin(t.GetAlpha()); 
+    xyz1[1] = +x * TMath::Sin(t.GetAlpha()) + y * TMath::Cos(t.GetAlpha());
+    xyz1[2] =  z;
 
-  for (Int_t nr=fTrSec[0]->GetLayerNumber(x); nr>plTPC; nr--) { 
+    // Calculate the mean material budget between start and
+    // end point of this prolongation step
+    AliTracker::MeanMaterialBudget(xyz0,xyz1,param);
 
-    y = t.GetY(); 
-    z = t.GetZ();
+    // Propagate the track to the X-position after the next step
+    if (!t.PropagateTo(x,param[1],param[0]*param[4])) {
+      return 0;
+    }
 
-    // first propagate to the outer surface of the current time bin 
-    fTrSec[s]->GetLayer(nr)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr)->GetX()-dx/2; 
-    
-    if(!t.PropagateTo(x,radLength,rho)) return 0;
+    // Rotate the track if necessary
     AdjustSector(&t);
-    if(!t.PropagateTo(x,radLength,rho)) return 0;
 
-    y = t.GetY(); 
-    z = t.GetZ();
+    // New track X-position
+    xpos = t.GetX();
 
-    // now propagate to the middle plane of the next time bin 
-    fTrSec[s]->GetLayer(nr-1)->GetPropagationParameters(y,z,dx,rho,radLength,lookForCluster);
-    x = fTrSec[s]->GetLayer(nr-1)->GetX(); 
-    
-    if(!t.PropagateTo(x,radLength,rho)) return 0;
-    AdjustSector(&t);
-    if(!t.PropagateTo(x,radLength,rho)) return 0;
   }
-  return 1;
-}         
-
-void AliTRDtracker::LoadEvent()
-{
-  // Fills clusters into TRD tracking_sectors 
-  // Note that the numbering scheme for the TRD tracking_sectors 
-  // differs from that of TRD sectors
-
-  ReadClusters(fClusters);
-  Int_t ncl=fClusters->GetEntriesFast();
-  cout<<"LoadSectors: sorting "<<ncl<<" clusters"<<endl;
-              
-  UInt_t index;
-  while (ncl--) {
-//    printf("\r %d left  ",ncl); 
-    AliTRDcluster *c=(AliTRDcluster*)fClusters->UncheckedAt(ncl);
-    Int_t detector=c->GetDetector();
-    Int_t localTimeBin=c->GetLocalTimeBin();
-    Int_t sector=fGeom->GetSector(detector);
-    Int_t plane=fGeom->GetPlane(detector);
-
-    Int_t trackingSector = CookSectorIndex(sector);
-
-    Int_t gtb = fTrSec[trackingSector]->CookTimeBinIndex(plane,localTimeBin);
-    if(gtb < 0) continue; 
-    Int_t layer = fTrSec[trackingSector]->GetLayerNumber(gtb);
 
-    index=ncl;
-    fTrSec[trackingSector]->GetLayer(layer)->InsertCluster(c,index);
-  }    
-  //  printf("\r\n");
+  return 1;
 
 }
 
 //_____________________________________________________________________________
 Int_t AliTRDtracker::LoadClusters(TTree *cTree)
 {
+  //
   // Fills clusters into TRD tracking_sectors 
   // Note that the numbering scheme for the TRD tracking_sectors 
   // differs from that of TRD sectors
+  //
 
-  if (ReadClusters(fClusters,cTree)) {
-     Error("LoadClusters","Problem with reading the clusters !");
-     return 1;
+       
+  if (ReadClusters(fClusters, cTree)) {
+    AliError("Problem with reading the clusters !");
+    return 1;
   }
-  Int_t ncl=fClusters->GetEntriesFast();
-  cout<<"\n LoadSectors: sorting "<<ncl<<" clusters"<<endl;
+  Int_t ncl  = fClusters->GetEntriesFast();
+  fNclusters = ncl;
+  AliInfo(Form("Sorting %d clusters",ncl));
               
   UInt_t index;
-  for (Int_t ichamber=0;ichamber<5;ichamber++)
-    for (Int_t isector=0;isector<18;isector++){
-      fHoles[ichamber][isector]=kTRUE;
-    }
+  while (ncl--) {
 
+    AliTRDcluster *c = (AliTRDcluster *) fClusters->UncheckedAt(ncl);
+    Int_t detector       = c->GetDetector();
+    Int_t localTimeBin   = c->GetLocalTimeBin();
+    Int_t sector         = fGeom->GetSector(detector);
+    Int_t layer          = fGeom->GetLayer(detector);
+    Int_t trackingSector = sector;
 
-  while (ncl--) {
-//    printf("\r %d left  ",ncl); 
-    AliTRDcluster *c=(AliTRDcluster*)fClusters->UncheckedAt(ncl);
-    Int_t detector=c->GetDetector();
-    Int_t localTimeBin=c->GetLocalTimeBin();
-    Int_t sector=fGeom->GetSector(detector);
-    Int_t plane=fGeom->GetPlane(detector);
-      
-    Int_t trackingSector = CookSectorIndex(sector);
-    if (c->GetLabel(0)>0){
-      Int_t chamber = fGeom->GetChamber(detector);
-      fHoles[chamber][trackingSector]=kFALSE;
+    //if (c->GetQ() > 10) {
+    //  Int_t stack = fGeom->GetStack(detector);
+    //}
+
+    Int_t gtb   = fTrSec[trackingSector]->CookTimeBinIndex(layer,localTimeBin);
+    if (gtb < 0) {
+      continue; 
     }
+    Int_t trLayer = fTrSec[trackingSector]->GetLayerNumber(gtb);
 
-    Int_t gtb = fTrSec[trackingSector]->CookTimeBinIndex(plane,localTimeBin);
-    if(gtb < 0) continue; 
-    Int_t layer = fTrSec[trackingSector]->GetLayerNumber(gtb);
+    index = ncl;
+
+    fHXCl->Fill(c->GetX());
+
+    fTrSec[trackingSector]->GetLayer(trLayer)->SetX(c->GetX());
+    fTrSec[trackingSector]->GetLayer(trLayer)->InsertCluster(c,index);
 
-    index=ncl;
-    fTrSec[trackingSector]->GetLayer(layer)->InsertCluster(c,index);
-  }    
-  //  printf("\r\n");
-  //
-  //
-  /*
-  for (Int_t isector=0;isector<18;isector++){
-    for (Int_t ichamber=0;ichamber<5;ichamber++)      
-      if (fHoles[ichamber][isector]!=fGeom->IsHole(0,ichamber,17-isector)) 
-       printf("Problem \t%d\t%d\t%d\t%d\n",isector,ichamber,fHoles[ichamber][isector],
-            fGeom->IsHole(0,ichamber,17-isector));
   }
-  */
+
   return 0;
+
 }
 
 //_____________________________________________________________________________
-void AliTRDtracker::UnloadEvent() 
+void AliTRDtracker::UnloadClusters() 
 { 
   //
   // Clears the arrays of clusters and tracks. Resets sectors and timebins 
   //
 
-  Int_t i, nentr;
+  Int_t i;
+  Int_t nentr;
 
   nentr = fClusters->GetEntriesFast();
-  for (i = 0; i < nentr; i++) delete fClusters->RemoveAt(i);
+  for (i = 0; i < nentr; i++) {
+    delete fClusters->RemoveAt(i);
+  }
+  fNclusters = 0;
 
   nentr = fSeeds->GetEntriesFast();
-  for (i = 0; i < nentr; i++) delete fSeeds->RemoveAt(i);
+  for (i = 0; i < nentr; i++) {
+    delete fSeeds->RemoveAt(i);
+  }
 
   nentr = fTracks->GetEntriesFast();
-  for (i = 0; i < nentr; i++) delete fTracks->RemoveAt(i);
-
-  Int_t nsec = AliTRDgeometry::kNsect;
+  for (i = 0; i < nentr; i++) {
+    delete fTracks->RemoveAt(i);
+  }
 
+  Int_t nsec = AliTRDgeometry::kNsector;
   for (i = 0; i < nsec; i++) {    
     for(Int_t pl = 0; pl < fTrSec[i]->GetNumberOfLayers(); pl++) {
       fTrSec[i]->GetLayer(pl)->Clear();
@@ -1943,335 +1302,1196 @@ void AliTRDtracker::UnloadEvent()
 
 }
 
-//__________________________________________________________________________
-void AliTRDtracker::MakeSeeds(Int_t inner, Int_t outer, Int_t turn)
+//_____________________________________________________________________________
+Int_t AliTRDtracker::Clusters2Tracks(AliESDEvent *esd)
 {
-  // Creates track seeds using clusters in timeBins=i1,i2
+  //
+  // Creates  seeds using clusters between  position inner plane  and outer plane 
+  //
 
-  if(turn > 2) {
-    cerr<<"MakeSeeds: turn "<<turn<<" exceeds the limit of 2"<<endl;
-    return;
-  }
+  const Double_t kMaxTheta =  1.0;
+  const Double_t kMaxPhi   =  2.0;
 
-  Double_t x[5], c[15];
-  Int_t maxSec=AliTRDgeometry::kNsect;
-  
-  Double_t alpha=AliTRDgeometry::GetAlpha();
-  Double_t shift=AliTRDgeometry::GetAlpha()/2.;
-  Double_t cs=cos(alpha), sn=sin(alpha);
-  Double_t cs2=cos(2.*alpha), sn2=sin(2.*alpha);
-    
-      
-  Int_t i2 = fTrSec[0]->GetLayerNumber(inner);
-  Int_t i1 = fTrSec[0]->GetLayerNumber(outer);
-      
-  Double_t x1 =fTrSec[0]->GetX(i1);
-  Double_t xx2=fTrSec[0]->GetX(i2);
-      
-  for (Int_t ns=0; ns<maxSec; ns++) {
-    
-    Int_t nl2 = *(fTrSec[(ns-2+maxSec)%maxSec]->GetLayer(i2));
-    Int_t nl=(*fTrSec[(ns-1+maxSec)%maxSec]->GetLayer(i2));
-    Int_t nm=(*fTrSec[ns]->GetLayer(i2));
-    Int_t nu=(*fTrSec[(ns+1)%maxSec]->GetLayer(i2));
-    Int_t nu2=(*fTrSec[(ns+2)%maxSec]->GetLayer(i2));
-    
-    AliTRDpropagationLayer& r1=*(fTrSec[ns]->GetLayer(i1));
-    
-    for (Int_t is=0; is < r1; is++) {
-      Double_t y1=r1[is]->GetY(), z1=r1[is]->GetZ();
-      
-      for (Int_t js=0; js < nl2+nl+nm+nu+nu2; js++) {
-        
-        const AliTRDcluster *cl;
-        Double_t x2,   y2,   z2;
-        Double_t x3=0., y3=0.;   
-        
-        if (js<nl2) {
-          if(turn != 2) continue;
-          AliTRDpropagationLayer& r2=*(fTrSec[(ns-2+maxSec)%maxSec]->GetLayer(i2));
-          cl=r2[js];
-          y2=cl->GetY(); z2=cl->GetZ();
-          
-          x2= xx2*cs2+y2*sn2;
-          y2=-xx2*sn2+y2*cs2;
-        }
-        else if (js<nl2+nl) {
-          if(turn != 1) continue;
-          AliTRDpropagationLayer& r2=*(fTrSec[(ns-1+maxSec)%maxSec]->GetLayer(i2));
-          cl=r2[js-nl2];
-          y2=cl->GetY(); z2=cl->GetZ();
-          
-          x2= xx2*cs+y2*sn;
-          y2=-xx2*sn+y2*cs;
-        }                                
-        else if (js<nl2+nl+nm) {
-          if(turn != 1) continue;
-          AliTRDpropagationLayer& r2=*(fTrSec[ns]->GetLayer(i2));
-          cl=r2[js-nl2-nl];
-          x2=xx2; y2=cl->GetY(); z2=cl->GetZ();
-        }
-        else if (js<nl2+nl+nm+nu) {
-          if(turn != 1) continue;
-          AliTRDpropagationLayer& r2=*(fTrSec[(ns+1)%maxSec]->GetLayer(i2));
-          cl=r2[js-nl2-nl-nm];
-          y2=cl->GetY(); z2=cl->GetZ();
-          
-          x2=xx2*cs-y2*sn;
-          y2=xx2*sn+y2*cs;
-        }              
-        else {
-          if(turn != 2) continue;
-          AliTRDpropagationLayer& r2=*(fTrSec[(ns+2)%maxSec]->GetLayer(i2));
-          cl=r2[js-nl2-nl-nm-nu];
-          y2=cl->GetY(); z2=cl->GetZ();
-          
-          x2=xx2*cs2-y2*sn2;
-          y2=xx2*sn2+y2*cs2;
-        }
-        
-        if(TMath::Abs(z1-z2) > fgkMaxSeedDeltaZ12) continue;
-        
-        Double_t zz=z1 - z1/x1*(x1-x2);
-        
-        if (TMath::Abs(zz-z2)>fgkMaxSeedDeltaZ) continue;
-        
-        Double_t d=(x2-x1)*(0.-y2)-(0.-x2)*(y2-y1);
-        if (d==0.) {cerr<<"TRD MakeSeeds: Straight seed !\n"; continue;}
-        
-        x[0]=y1;
-        x[1]=z1;
-        x[4]=f1trd(x1,y1,x2,y2,x3,y3);
-        
-        if (TMath::Abs(x[4]) > fgkMaxSeedC) continue;      
-        
-        x[2]=f2trd(x1,y1,x2,y2,x3,y3);
-        
-        if (TMath::Abs(x[4]*x1-x[2]) >= 0.99999) continue;
-        
-        x[3]=f3trd(x1,y1,x2,y2,z1,z2);
-        
-        if (TMath::Abs(x[3]) > fgkMaxSeedTan) continue;
-        
-        Double_t a=asin(x[2]);
-        Double_t zv=z1 - x[3]/x[4]*(a+asin(x[4]*x1-x[2]));
-        
-        if (TMath::Abs(zv)>fgkMaxSeedVertexZ) continue;
-        
-        Double_t sy1=r1[is]->GetSigmaY2(), sz1=r1[is]->GetSigmaZ2();
-        Double_t sy2=cl->GetSigmaY2(),     sz2=cl->GetSigmaZ2();
-        Double_t sy3=fgkSeedErrorSY3, sy=fgkSeedErrorSY, sz=fgkSeedErrorSZ;  
-
-        // Tilt changes
-        Double_t h01 = GetTiltFactor(r1[is]);
-       Double_t xuFactor = 100.;
-       if(fNoTilt) { 
-         h01 = 0;
-         xuFactor = 1;
-       }
+  const Double_t kRoad0y   =  6.0; // Road for middle cluster 
+  const Double_t kRoad0z   =  8.5; // Road for middle cluster 
 
-        sy1=sy1+sz1*h01*h01;
-        Double_t syz=sz1*(-h01);
-        // end of tilt changes
-        
-        Double_t f40=(f1trd(x1,y1+sy,x2,y2,x3,y3)-x[4])/sy;
-        Double_t f42=(f1trd(x1,y1,x2,y2+sy,x3,y3)-x[4])/sy;
-        Double_t f43=(f1trd(x1,y1,x2,y2,x3,y3+sy)-x[4])/sy;
-        Double_t f20=(f2trd(x1,y1+sy,x2,y2,x3,y3)-x[2])/sy;
-        Double_t f22=(f2trd(x1,y1,x2,y2+sy,x3,y3)-x[2])/sy;
-        Double_t f23=(f2trd(x1,y1,x2,y2,x3,y3+sy)-x[2])/sy;
-        Double_t f30=(f3trd(x1,y1+sy,x2,y2,z1,z2)-x[3])/sy;
-        Double_t f31=(f3trd(x1,y1,x2,y2,z1+sz,z2)-x[3])/sz;
-        Double_t f32=(f3trd(x1,y1,x2,y2+sy,z1,z2)-x[3])/sy;
-        Double_t f34=(f3trd(x1,y1,x2,y2,z1,z2+sz)-x[3])/sz;    
+  const Double_t kRoad1y   =  2.0; // Road in y for seeded cluster
+  const Double_t kRoad1z   = 20.0; // Road in z for seeded cluster
 
-        
-        c[0]=sy1;
-        //        c[1]=0.;       c[2]=sz1;
-        c[1]=syz;       c[2]=sz1*xuFactor;
-        c[3]=f20*sy1;  c[4]=0.;       c[5]=f20*sy1*f20+f22*sy2*f22+f23*sy3*f23;
-        c[6]=f30*sy1;  c[7]=f31*sz1;  c[8]=f30*sy1*f20+f32*sy2*f22;
-                       c[9]=f30*sy1*f30+f31*sz1*f31+f32*sy2*f32+f34*sz2*f34;
-        c[10]=f40*sy1; c[11]=0.; c[12]=f40*sy1*f20+f42*sy2*f22+f43*sy3*f23;
-        c[13]=f30*sy1*f40+f32*sy2*f42;
-        c[14]=f40*sy1*f40+f42*sy2*f42+f43*sy3*f43;      
-        
-        UInt_t index=r1.GetIndex(is);
-        
-        AliTRDtrack *track=new AliTRDtrack(r1[is],index,x,c,x1,ns*alpha+shift);
+  const Double_t kRoad2y   =  3.0; // Road in y for extrapolated cluster
+  const Double_t kRoad2z   = 20.0; // Road in z for extrapolated cluster
+  const Int_t    kMaxSeed  = 3000;
 
-        Int_t rc=FollowProlongation(*track, i2);     
-        
-        if ((rc < 1) ||
-            (track->GetNumberOfClusters() < 
-             (outer-inner)*fgkMinClustersInSeed)) delete track;
-        else {
-          fSeeds->AddLast(track); fNseeds++;
-//          cerr<<"\r found seed "<<fNseeds;
-        }
+  Int_t maxSec = AliTRDgeometry::kNsector;  
+
+  // Linear fitters in planes
+  TLinearFitter fitterTC(2,"hyp2");  // Fitting with tilting pads - kz fixed - kz= Z/x, + vertex const
+  TLinearFitter fitterT2(4,"hyp4");  // Fitting with tilting pads - kz not fixed
+  fitterTC.StoreData(kTRUE);
+  fitterT2.StoreData(kTRUE);
+  AliRieman rieman(1000);            // Rieman fitter
+  AliRieman rieman2(1000);           // Rieman fitter
+
+  // Find the maximal and minimal layer for the planes
+  Int_t layers[6][2];
+  AliTRDpropagationLayer *reflayers[6];
+  for (Int_t i = 0; i < 6; i++) {
+    layers[i][0] = 10000; 
+    layers[i][1] = 0;
+  }
+  for (Int_t ns = 0; ns < maxSec; ns++) {
+    for (Int_t ilayer = 0; ilayer < fTrSec[ns]->GetNumberOfLayers(); ilayer++) {
+      AliTRDpropagationLayer &propLayer = *(fTrSec[ns]->GetLayer(ilayer));
+      if (propLayer == 0) {
+        continue;
+      }
+      Int_t det   = propLayer[0]->GetDetector();    
+      Int_t layer = fGeom->GetLayer(det);
+      if (ilayer < layers[layer][0]) {
+        layers[layer][0] = ilayer;
+      }
+      if (ilayer > layers[layer][1]) {
+        layers[layer][1] = ilayer;
       }
     }
   }
-}            
 
-//_____________________________________________________________________________
-Int_t AliTRDtracker::ReadClusters(TObjArray *array, TTree *ClusterTree) 
-{
-  //
-  // Reads AliTRDclusters (option >= 0) or AliTRDrecPoints (option < 0) 
-  // from the file. The names of the cluster tree and branches 
-  // should match the ones used in AliTRDclusterizer::WriteClusters()
-  //
-  TObjArray *clusterArray = new TObjArray(400); 
-  
-  TBranch *branch=ClusterTree->GetBranch("TRDcluster");
-  if (!branch) {
-    Error("ReadClusters","Can't get the branch !");
-    return 1;
-  }
-  branch->SetAddress(&clusterArray); 
-  
-  Int_t nEntries = (Int_t) ClusterTree->GetEntries();
-  //  printf("found %d entries in %s.\n",nEntries,ClusterTree->GetName());
-  
-  // Loop through all entries in the tree
-  Int_t nbytes = 0;
-  AliTRDcluster *c = 0;
-  //  printf("\n");
+  AliTRDpadPlane *padPlane = fGeom->GetPadPlane(0,0);
+  Double_t h01 = TMath::Tan(-TMath::Pi() / 180.0 * padPlane->GetTiltingAngle());
+  Double_t hL[6];                                                // Tilting angle
+  Double_t xcl[6];                                               // X - position of reference cluster
+  Double_t ycl[6];                                               // Y - position of reference cluster
+  Double_t zcl[6];                                               // Z - position of reference cluster
 
-  for (Int_t iEntry = 0; iEntry < nEntries; iEntry++) {    
-    
-    // Import the tree
-    nbytes += ClusterTree->GetEvent(iEntry);  
-    
-    // Get the number of points in the detector
-    Int_t nCluster = clusterArray->GetEntriesFast();  
-//    printf("\r Read %d clusters from entry %d", nCluster, iEntry);
-    
-    // Loop through all TRD digits
-    for (Int_t iCluster = 0; iCluster < nCluster; iCluster++) { 
-      c = (AliTRDcluster*)clusterArray->UncheckedAt(iCluster);
-      AliTRDcluster *co = new AliTRDcluster(*c);
-      co->SetSigmaY2(c->GetSigmaY2() * fSY2corr);
-      Int_t ltb = co->GetLocalTimeBin();
-      if(ltb == 19) co->SetSigmaZ2(c->GetSigmaZ2());
-      else if(fNoTilt) co->SetSigmaZ2(c->GetSigmaZ2() * fSZ2corr);
-      array->AddLast(co);
-      delete clusterArray->RemoveAt(iCluster); 
+  AliTRDcluster *cl[6] = {    0,    0,    0,    0,    0,    0 }; // Seeding clusters
+  Float_t padlength[6] = { 10.0, 10.0, 10.0, 10.0, 10.0, 10.0 }; // Current pad-length 
+
+  Double_t chi2R  = 0.0;
+  Double_t chi2Z  = 0.0;
+  Double_t chi2RF = 0.0;
+  Double_t chi2ZF = 0.0;
+
+  Int_t nclusters;                                               // Total number of clusters
+  for (Int_t i = 0; i < 6; i++) {
+    hL[i] = h01; 
+    if (i%2==1) {
+      hL[i]*=-1.0;
     }
   }
 
-  delete clusterArray;
+  // Registered seed
+  AliTRDseed *pseed = new AliTRDseed[kMaxSeed*6];
+  AliTRDseed *seed[kMaxSeed];
+  for (Int_t iseed = 0; iseed < kMaxSeed; iseed++) {
+    seed[iseed]= &pseed[iseed*6];
+  }
+  AliTRDseed *cseed = seed[0];
+
+  Double_t seedquality[kMaxSeed];  
+  Double_t seedquality2[kMaxSeed];  
+  Double_t seedparams[kMaxSeed][7];
+  Int_t    seedlayer[kMaxSeed];
+  Int_t    registered = 0;
+  Int_t    sort[kMaxSeed];
+
+  //
+  // Seeding part
+  //
+  for (Int_t ns = 0; ns < maxSec; ns++) { // Loop over sectors
+  //for (Int_t ns = 0; ns < 5; ns++) { // Loop over sectors
+
+    registered   = 0; // Reset registerd seed counter
+    cseed        = seed[registered];
+    Float_t iter = 0.0;
+
+    for (Int_t sLayer = 2; sLayer >= 0; sLayer--) {
+      //for (Int_t dseed = 5; dseed < 15; dseed += 3) {
+
+      iter += 1.0;
+      Int_t dseed = 5 + Int_t(iter) * 3;
+
+      // Initialize seeding layers
+      for (Int_t ilayer = 0; ilayer < 6; ilayer++) {
+       reflayers[ilayer] = fTrSec[ns]->GetLayer(layers[ilayer][1]-dseed);
+       xcl[ilayer]       = reflayers[ilayer]->GetX();
+      }
+
+      Double_t xref = (xcl[sLayer+1] + xcl[sLayer+2]) * 0.5;      
+      AliTRDpropagationLayer &layer0 = *reflayers[sLayer+0];
+      AliTRDpropagationLayer &layer1 = *reflayers[sLayer+1];
+      AliTRDpropagationLayer &layer2 = *reflayers[sLayer+2];
+      AliTRDpropagationLayer &layer3 = *reflayers[sLayer+3];
+
+      Int_t maxn3 = layer3;
+      for (Int_t icl3 = 0; icl3 < maxn3; icl3++) {
+
+       AliTRDcluster *cl3 = layer3[icl3];
+       if (!cl3) {
+          continue;
+       }
+       padlength[sLayer+3] = TMath::Sqrt(cl3->GetSigmaZ2() * 12.0);
+       ycl[sLayer+3] = cl3->GetY();
+       zcl[sLayer+3] = cl3->GetZ();
+       Float_t yymin0 = ycl[sLayer+3] - 1.0 - kMaxPhi * (xcl[sLayer+3]-xcl[sLayer+0]);
+       Float_t yymax0 = ycl[sLayer+3] + 1.0 + kMaxPhi * (xcl[sLayer+3]-xcl[sLayer+0]);
+       Int_t   maxn0  = layer0;
+
+       for (Int_t icl0 = layer0.Find(yymin0); icl0 < maxn0; icl0++) {
+
+         AliTRDcluster *cl0 = layer0[icl0];
+         if (!cl0) {
+            continue;
+         }
+         if (cl3->IsUsed() && cl0->IsUsed()) {
+            continue;
+         }
+         ycl[sLayer+0] = cl0->GetY();
+         zcl[sLayer+0] = cl0->GetZ();
+         if (ycl[sLayer+0] > yymax0) {
+            break;
+         }
+         Double_t tanphi     = (ycl[sLayer+3]-ycl[sLayer+0]) / (xcl[sLayer+3]-xcl[sLayer+0]); 
+         if (TMath::Abs(tanphi)   > kMaxPhi) {
+            continue;
+         }
+         Double_t tantheta   = (zcl[sLayer+3]-zcl[sLayer+0]) / (xcl[sLayer+3]-xcl[sLayer+0]); 
+         if (TMath::Abs(tantheta) > kMaxTheta) {
+            continue; 
+         }
+         padlength[sLayer+0] = TMath::Sqrt(cl0->GetSigmaZ2() * 12.0);
+
+         // Expected position in 1 layer
+         Double_t y1exp = ycl[sLayer+0] + (tanphi)   * (xcl[sLayer+1]-xcl[sLayer+0]);    
+         Double_t z1exp = zcl[sLayer+0] + (tantheta) * (xcl[sLayer+1]-xcl[sLayer+0]);    
+         Float_t yymin1 = y1exp - kRoad0y - tanphi;
+         Float_t yymax1 = y1exp + kRoad0y + tanphi;
+         Int_t   maxn1  = layer1;
+
+         for (Int_t icl1 = layer1.Find(yymin1); icl1 < maxn1; icl1++) {
+
+           AliTRDcluster *cl1 = layer1[icl1];
+           if (!cl1) {
+              continue;
+           }
+           Int_t nusedCl = 0;
+           if (cl3->IsUsed()) nusedCl++;
+           if (cl0->IsUsed()) nusedCl++;
+           if (cl1->IsUsed()) nusedCl++;
+           if (nusedCl > 1) {
+              continue;
+           }
+           ycl[sLayer+1] = cl1->GetY();
+           zcl[sLayer+1] = cl1->GetZ();
+           if (ycl[sLayer+1] > yymax1) {
+              break;
+           }
+           if (TMath::Abs(ycl[sLayer+1]-y1exp) > kRoad0y+tanphi) {
+              continue;
+           }
+           if (TMath::Abs(zcl[sLayer+1]-z1exp) > kRoad0z) {
+              continue;
+           }
+           padlength[sLayer+1] = TMath::Sqrt(cl1->GetSigmaZ2() * 12.0);
+
+           Double_t y2exp  = ycl[sLayer+0]+(tanphi)   * (xcl[sLayer+2]-xcl[sLayer+0]) + (ycl[sLayer+1]-y1exp);   
+           Double_t z2exp  = zcl[sLayer+0]+(tantheta) * (xcl[sLayer+2]-xcl[sLayer+0]);
+           Int_t    index2 = layer2.FindNearestCluster(y2exp,z2exp,kRoad1y,kRoad1z);
+           if (index2 <= 0) {
+              continue; 
+           }
+           AliTRDcluster *cl2 = (AliTRDcluster *) GetCluster(index2);
+           padlength[sLayer+2] = TMath::Sqrt(cl2->GetSigmaZ2() * 12.0);
+           ycl[sLayer+2]       = cl2->GetY();
+           zcl[sLayer+2]       = cl2->GetZ();
+           if (TMath::Abs(cl2->GetZ()-z2exp) > kRoad0z) {
+              continue;
+           }
+
+           rieman.Reset();
+           rieman.AddPoint(xcl[sLayer+0],ycl[sLayer+0],zcl[sLayer+0],1,10);
+           rieman.AddPoint(xcl[sLayer+1],ycl[sLayer+1],zcl[sLayer+1],1,10);
+           rieman.AddPoint(xcl[sLayer+3],ycl[sLayer+3],zcl[sLayer+3],1,10);        
+           rieman.AddPoint(xcl[sLayer+2],ycl[sLayer+2],zcl[sLayer+2],1,10);
+           rieman.Update();
+
+           // Reset fitter
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             cseed[iLayer].Reset();
+           }     
+           chi2Z = 0.0; 
+            chi2R = 0.0;
+
+           for (Int_t iLayer = 0; iLayer < 4; iLayer++) {
+             cseed[sLayer+iLayer].SetZref(0,rieman.GetZat(xcl[sLayer+iLayer]));
+             chi2Z += (cseed[sLayer+iLayer].GetZref(0)- zcl[sLayer+iLayer])
+                    * (cseed[sLayer+iLayer].GetZref(0)- zcl[sLayer+iLayer]);
+             cseed[sLayer+iLayer].SetZref(1,rieman.GetDZat(xcl[sLayer+iLayer]));             
+             cseed[sLayer+iLayer].SetYref(0,rieman.GetYat(xcl[sLayer+iLayer]));
+             chi2R += (cseed[sLayer+iLayer].GetYref(0)- ycl[sLayer+iLayer])
+                    * (cseed[sLayer+iLayer].GetYref(0)- ycl[sLayer+iLayer]);
+             cseed[sLayer+iLayer].SetYref(1,rieman.GetDYat(xcl[sLayer+iLayer]));
+           }
+           if (TMath::Sqrt(chi2R) > 1.0/iter) {
+              continue;
+           }
+           if (TMath::Sqrt(chi2Z) > 7.0/iter) {
+              continue;
+           }
+
+           Float_t minmax[2] = { -100.0,  100.0 };
+           for (Int_t iLayer = 0; iLayer < 4; iLayer++) {
+             Float_t max = zcl[sLayer+iLayer]+padlength[sLayer+iLayer] * 0.5
+                          + 1.0 - cseed[sLayer+iLayer].GetZref(0);
+             if (max < minmax[1]) {
+                minmax[1] = max; 
+             }
+             Float_t min = zcl[sLayer+iLayer]-padlength[sLayer+iLayer] * 0.5
+                          - 1.0 - cseed[sLayer+iLayer].GetZref(0);
+             if (min > minmax[0]) {
+                minmax[0] = min; 
+             }
+           }
+
+           Bool_t isFake = kFALSE; 
+           if (cl0->GetLabel(0) != cl3->GetLabel(0)) {
+              isFake = kTRUE;
+           }
+           if (cl1->GetLabel(0) != cl3->GetLabel(0)) {
+              isFake = kTRUE;
+           }
+           if (cl2->GetLabel(0) != cl3->GetLabel(0)) {
+              isFake = kTRUE;
+           }
+
+           if (fReconstructor->GetStreamLevel(AliTRDReconstructor::kTracker) > 0) {
+             if ((!isFake) || ((icl3%10) == 0)) {  // Debugging print
+               TTreeSRedirector &cstream = *fDebugStreamer;
+               cstream << "Seeds0"
+                       << "isFake=" << isFake
+                       << "Cl0.="   << cl0
+                       << "Cl1.="   << cl1
+                       << "Cl2.="   << cl2
+                       << "Cl3.="   << cl3
+                       << "Xref="   << xref
+                       << "X0="     << xcl[sLayer+0]
+                       << "X1="     << xcl[sLayer+1]
+                       << "X2="     << xcl[sLayer+2]
+                       << "X3="     << xcl[sLayer+3]
+                       << "Y2exp="  << y2exp
+                       << "Z2exp="  << z2exp
+                       << "Chi2R="  << chi2R
+                       << "Chi2Z="  << chi2Z
+                       << "Seed0.=" << &cseed[sLayer+0]
+                       << "Seed1.=" << &cseed[sLayer+1]
+                       << "Seed2.=" << &cseed[sLayer+2]
+                       << "Seed3.=" << &cseed[sLayer+3]
+                       << "Zmin="   << minmax[0]
+                       << "Zmax="   << minmax[1]
+                       << "\n";
+             }
+           }
+
+           ////////////////////////////////////////////////////////////////////////////////////
+           //
+           // Fit seeding part
+           //
+           ////////////////////////////////////////////////////////////////////////////////////
+
+           cl[sLayer+0] = cl0;
+           cl[sLayer+1] = cl1;
+           cl[sLayer+2] = cl2;
+           cl[sLayer+3] = cl3;
+           Bool_t isOK = kTRUE;
+
+           for (Int_t jLayer = 0; jLayer < 4; jLayer++) {
+
+             cseed[sLayer+jLayer].SetTilt(hL[sLayer+jLayer]);
+             cseed[sLayer+jLayer].SetPadLength(padlength[sLayer+jLayer]);
+             cseed[sLayer+jLayer].SetX0(xcl[sLayer+jLayer]);
+
+             for (Int_t jter = 0; jter < 2; jter++) {
+
+               //
+               // In iteration 0 we try only one pad-row
+               // If quality not sufficient we try 2 pad-rows - about 5% of tracks cross 2 pad-rows
+               //
+               AliTRDseed tseed = cseed[sLayer+jLayer];
+               Float_t    roadz = padlength[sLayer+jLayer] * 0.5;
+               if (jter > 0) {
+                  roadz = padlength[sLayer+jLayer];
+               }
+
+               Float_t quality = 10000.0;
+
+               for (Int_t iTime = 2; iTime < 20; iTime++) { 
+
+                 AliTRDpropagationLayer &layer = *(fTrSec[ns]->GetLayer(layers[sLayer+jLayer][1]-iTime));
+                 Double_t dxlayer = layer.GetX() - xcl[sLayer+jLayer];          
+                 Double_t zexp    = cl[sLayer+jLayer]->GetZ();
+
+                 if (jter > 0) {
+                   // Try 2 pad-rows in second iteration
+                   zexp = tseed.GetZref(0) + tseed.GetZref(1) * dxlayer;
+                   if (zexp > cl[sLayer+jLayer]->GetZ()) {
+                      zexp = cl[sLayer+jLayer]->GetZ() + padlength[sLayer+jLayer]*0.5;
+                   }
+                   if (zexp < cl[sLayer+jLayer]->GetZ()) {
+                      zexp = cl[sLayer+jLayer]->GetZ() - padlength[sLayer+jLayer]*0.5;
+                   }
+                 }
+
+                 Double_t yexp  = tseed.GetYref(0) + tseed.GetYref(1) * dxlayer;
+                 Int_t    index = layer.FindNearestCluster(yexp,zexp,kRoad1y,roadz);
+                 if (index <= 0) {
+                    continue; 
+                 }
+                 AliTRDcluster *clu = (AliTRDcluster *) GetCluster(index);           
+
+                 tseed.SetIndexes(iTime,index);
+                 tseed.SetClusters(iTime,clu);  // Register cluster
+                 tseed.SetX(iTime,dxlayer);     // Register cluster
+                 tseed.SetY(iTime,clu->GetY()); // Register cluster
+                 tseed.SetZ(iTime,clu->GetZ()); // Register cluster
+
+               }
+
+               tseed.Update();
+
+               // Count the number of clusters and distortions into quality
+               Float_t dangle   = tseed.GetYfit(1) - tseed.GetYref(1);
+               Float_t tquality = (18.0 - tseed.GetN2()) / 2.0 + TMath::Abs(dangle) / 0.1
+                                 + TMath::Abs(tseed.GetYfit(0) - tseed.GetYref(0))   / 0.2
+                                 + 2.0 * TMath::Abs(tseed.GetMeanz() - tseed.GetZref(0)) / padlength[jLayer];
+               if ((jter == 0) && tseed.IsOK()) {
+                 cseed[sLayer+jLayer] = tseed;
+                 quality              = tquality;
+                 if (tquality < 5) {
+                    break;  
+                 }
+               }
+               if (tseed.IsOK() && (tquality < quality)) {
+                 cseed[sLayer+jLayer] = tseed;
+               }
+       
+             } // Loop: jter
+
+             if (!cseed[sLayer+jLayer].IsOK()) {
+               isOK = kFALSE;
+               break;
+             }
+
+             cseed[sLayer+jLayer].CookLabels();
+             cseed[sLayer+jLayer].UpdateUsed();
+             nusedCl += cseed[sLayer+jLayer].GetNUsed();
+             if (nusedCl > 25) {
+               isOK = kFALSE;
+               break;
+             }
+
+           } // Loop: jLayer
+
+           if (!isOK) {
+              continue;
+           }
+           nclusters = 0;
+           for (Int_t iLayer = 0; iLayer < 4; iLayer++) {
+             if (cseed[sLayer+iLayer].IsOK()) {
+               nclusters += cseed[sLayer+iLayer].GetN2();          
+             }
+           }
+
+           // Iteration 0
+           rieman.Reset();
+           for (Int_t iLayer = 0; iLayer < 4; iLayer++) {
+             rieman.AddPoint(xcl[sLayer+iLayer]
+                            ,cseed[sLayer+iLayer].GetYfitR(0)
+                            ,cseed[sLayer+iLayer].GetZProb()
+                             ,1
+                             ,10);
+           }
+           rieman.Update();
+
+           chi2R = 0.0; 
+            chi2Z = 0.0;
+
+           for (Int_t iLayer = 0; iLayer < 4; iLayer++) {
+             cseed[sLayer+iLayer].SetYref(0,rieman.GetYat(xcl[sLayer+iLayer]));
+             chi2R += (cseed[sLayer+iLayer].GetYref(0) - cseed[sLayer+iLayer].GetYfitR(0))
+                     * (cseed[sLayer+iLayer].GetYref(0) - cseed[sLayer+iLayer].GetYfitR(0));
+             cseed[sLayer+iLayer].SetYref(1,rieman.GetDYat(xcl[sLayer+iLayer]));
+             cseed[sLayer+iLayer].SetZref(0,rieman.GetZat(xcl[sLayer+iLayer]));
+             chi2Z += (cseed[sLayer+iLayer].GetZref(0) - cseed[sLayer+iLayer].GetMeanz())
+                     * (cseed[sLayer+iLayer].GetZref(0) - cseed[sLayer+iLayer].GetMeanz());
+             cseed[sLayer+iLayer].SetZref(1,rieman.GetDZat(xcl[sLayer+iLayer]));
+           }
+           Double_t curv = rieman.GetC();
+
+           //
+           // Likelihoods
+           //
+           Double_t sumda     = TMath::Abs(cseed[sLayer+0].GetYfitR(1) - cseed[sLayer+0].GetYref(1))
+                               + TMath::Abs(cseed[sLayer+1].GetYfitR(1) - cseed[sLayer+1].GetYref(1))
+                               + TMath::Abs(cseed[sLayer+2].GetYfitR(1) - cseed[sLayer+2].GetYref(1))
+                               + TMath::Abs(cseed[sLayer+3].GetYfitR(1) - cseed[sLayer+3].GetYref(1));
+           Double_t likea     = TMath::Exp(-sumda*10.6);
+           Double_t likechi2  = 0.0000000001;
+           if (chi2R < 0.5) {
+              likechi2 += TMath::Exp(-TMath::Sqrt(chi2R) * 7.73);
+           }
+           Double_t likechi2z = TMath::Exp(-chi2Z * 0.088) / TMath::Exp(-chi2Z * 0.019);
+           Double_t likeN     = TMath::Exp(-(72 - nclusters) * 0.19);
+           Double_t like      = likea * likechi2 * likechi2z * likeN;
+           Double_t likePrimY = TMath::Exp(-TMath::Abs(cseed[sLayer+0].GetYref(1) - 130.0*curv) * 1.9);
+           Double_t likePrimZ = TMath::Exp(-TMath::Abs(cseed[sLayer+0].GetZref(1)
+                                                      - cseed[sLayer+0].GetZref(0) / xcl[sLayer+0]) * 5.9);
+           Double_t likePrim  = TMath::Max(likePrimY*likePrimZ,0.0005);
+                                           
+           seedquality[registered] = like; 
+           seedlayer[registered]   = sLayer;
+           if (TMath::Log(0.000000000000001 + like) < -15) {
+              continue;
+           }
+           AliTRDseed seedb[6];
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             seedb[iLayer] = cseed[iLayer]; 
+           }
+
+           ////////////////////////////////////////////////////////////////////////////////////
+           //
+           // Full track fit part
+           //
+           ////////////////////////////////////////////////////////////////////////////////////
+
+           Int_t nlayers  = 0;
+           Int_t nusedf   = 0;
+           Int_t findable = 0;
+
+           //
+           // Add new layers  - avoid long extrapolation
+           //
+           Int_t tLayer[2] = { 0, 0 };
+           if (sLayer == 2) {
+              tLayer[0] = 1; 
+              tLayer[1] = 0;
+            }
+           if (sLayer == 1) {
+              tLayer[0] = 5; 
+              tLayer[1] = 0;
+            }
+           if (sLayer == 0) {
+              tLayer[0] = 4; 
+              tLayer[1] = 5;
+            }
+
+           for (Int_t iLayer = 0; iLayer < 2; iLayer++) {
+             Int_t jLayer = tLayer[iLayer]; // Set tracking layer            
+             cseed[jLayer].Reset();
+             cseed[jLayer].SetTilt(hL[jLayer]);
+             cseed[jLayer].SetPadLength(padlength[jLayer]);
+             cseed[jLayer].SetX0(xcl[jLayer]);
+             // Get pad length and rough cluster
+             Int_t indexdummy = reflayers[jLayer]->FindNearestCluster(cseed[jLayer].GetYref(0)
+                                                                     ,cseed[jLayer].GetZref(0)
+                                                                      ,kRoad2y
+                                                                      ,kRoad2z);
+             if (indexdummy <= 0) {
+                continue; 
+             }
+             AliTRDcluster *cldummy = (AliTRDcluster *) GetCluster(indexdummy);
+             padlength[jLayer]      = TMath::Sqrt(cldummy->GetSigmaZ2() * 12.0);
+           }
+           AliTRDseed::FitRiemanTilt(cseed,kTRUE);
+
+           for (Int_t iLayer = 0; iLayer < 2; iLayer++) {
+
+             Int_t    jLayer = tLayer[iLayer];      // set tracking layer      
+             if ((jLayer == 0) && !(cseed[1].IsOK())) {
+                continue;  // break not allowed
+             }
+             if ((jLayer == 5) && !(cseed[4].IsOK())) {
+                continue;  // break not allowed
+             }
+             Float_t  zexp   = cseed[jLayer].GetZref(0);
+             Double_t zroad  = padlength[jLayer] * 0.5 + 1.0;
+
+             for (Int_t jter = 0; jter < 2; jter++) {
+
+               AliTRDseed tseed = cseed[jLayer];
+               Float_t quality = 10000.0;
+
+               for (Int_t iTime = 2; iTime < 20; iTime++) { 
+                 AliTRDpropagationLayer &layer = *(fTrSec[ns]->GetLayer(layers[jLayer][1]-iTime));
+                 Double_t dxlayer = layer.GetX()-xcl[jLayer];
+                 Double_t yexp    = tseed.GetYref(0) + tseed.GetYref(1) * dxlayer;
+                 Float_t  yroad   = kRoad1y;
+                 Int_t    index   = layer.FindNearestCluster(yexp,zexp,yroad,zroad);
+                 if (index <= 0) {
+                    continue; 
+                 }
+                 AliTRDcluster *clu = (AliTRDcluster *) GetCluster(index);           
+                 tseed.SetIndexes(iTime,index);
+                 tseed.SetClusters(iTime,clu);  // Register cluster
+                 tseed.SetX(iTime,dxlayer);     // Register cluster
+                 tseed.SetY(iTime,clu->GetY()); // Register cluster
+                 tseed.SetZ(iTime,clu->GetZ()); // Register cluster
+               }
+
+               tseed.Update();
+               if (tseed.IsOK()) {
+                 Float_t dangle   = tseed.GetYfit(1) - tseed.GetYref(1);
+                 Float_t tquality = (18.0 - tseed.GetN2())/2.0 + TMath::Abs(dangle) / 0.1
+                                   + TMath::Abs(tseed.GetYfit(0) - tseed.GetYref(0)) / 0.2
+                                   + 2.0 * TMath::Abs(tseed.GetMeanz() - tseed.GetZref(0)) / padlength[jLayer];
+                 if (tquality < quality) {
+                   cseed[jLayer] = tseed;
+                   quality       = tquality;
+                 }
+               }
+
+               zroad *= 2.0;
+
+             } // Loop: jter
+
+             if ( cseed[jLayer].IsOK()) {
+               cseed[jLayer].CookLabels();
+               cseed[jLayer].UpdateUsed();
+               nusedf += cseed[jLayer].GetNUsed();
+               AliTRDseed::FitRiemanTilt(cseed,kTRUE);
+             }
+
+           } // Loop: iLayer
+
+           // Make copy
+           AliTRDseed bseed[6];
+           for (Int_t jLayer = 0; jLayer < 6; jLayer++) {
+             bseed[jLayer] = cseed[jLayer];
+           }
+           Float_t lastquality = 10000.0;
+           Float_t lastchi2    = 10000.0;
+           Float_t chi2        =  1000.0;
+
+           for (Int_t jter = 0; jter < 4; jter++) {
+
+             // Sort tracklets according "quality", try to "improve" 4 worst 
+             Float_t sumquality = 0.0;
+             Float_t squality[6];
+             Int_t   sortindexes[6];
+
+             for (Int_t jLayer = 0; jLayer < 6; jLayer++) {
+               if (bseed[jLayer].IsOK()) { 
+                 AliTRDseed &tseed = bseed[jLayer];
+                 Double_t zcor     = tseed.GetTilt() * (tseed.GetZProb() - tseed.GetZref(0));
+                 Float_t  dangle   = tseed.GetYfit(1) - tseed.GetYref(1);
+                 Float_t  tquality = (18.0 - tseed.GetN2()) / 2.0 + TMath::Abs(dangle)        / 0.1
+                                    + TMath::Abs(tseed.GetYfit(0) - (tseed.GetYref(0) - zcor)) / 0.2
+                                    + 2.0 * TMath::Abs(tseed.GetMeanz() - tseed.GetZref(0))    / padlength[jLayer];
+                 squality[jLayer]  = tquality;
+               }
+               else {
+                  squality[jLayer] = -1.0;
+               }
+               sumquality +=squality[jLayer];
+             }
+
+             if ((sumquality >= lastquality) ||  
+                  (chi2       >     lastchi2)) {
+                break;
+             }
+             lastquality = sumquality;  
+             lastchi2    = chi2;
+             if (jter > 0) {
+               for (Int_t jLayer = 0; jLayer < 6; jLayer++) {
+                 cseed[jLayer] = bseed[jLayer];
+               }
+             }
+             TMath::Sort(6,squality,sortindexes,kFALSE);
+
+             for (Int_t jLayer = 5; jLayer > 1; jLayer--) {
+
+               Int_t bLayer = sortindexes[jLayer];
+               AliTRDseed tseed = bseed[bLayer];
+
+               for (Int_t iTime = 2; iTime < 20; iTime++) { 
+
+                 AliTRDpropagationLayer &layer = *(fTrSec[ns]->GetLayer(layers[bLayer][1]-iTime));
+                 Double_t dxlayer = layer.GetX() - xcl[bLayer];
+                 Double_t zexp    = tseed.GetZref(0);
+                 Double_t zcor    = tseed.GetTilt() * (tseed.GetZProb() - tseed.GetZref(0));
+                 Float_t  roadz   = padlength[bLayer] + 1;
+                 if (TMath::Abs(tseed.GetZProb() - zexp) > 0.5*padlength[bLayer]) {
+                    roadz = padlength[bLayer] * 0.5;
+                  }
+                 if (tseed.GetZfit(1)*tseed.GetZref(1)   < 0.0) {
+                    roadz = padlength[bLayer] * 0.5;
+                  }
+                 if (TMath::Abs(tseed.GetZProb() - zexp) < 0.1*padlength[bLayer]) {
+                   zexp  = tseed.GetZProb(); 
+                   roadz = padlength[bLayer] * 0.5;
+                 }
+
+                 Double_t yexp  = tseed.GetYref(0) + tseed.GetYref(1) * dxlayer - zcor;
+                 Int_t    index = layer.FindNearestCluster(yexp,zexp,kRoad1y,roadz);
+                 if (index <= 0) {
+                    continue; 
+                 }
+                 AliTRDcluster *clu = (AliTRDcluster *) GetCluster(index);           
+
+                 tseed.SetIndexes(iTime,index);
+                 tseed.SetClusters(iTime,clu);  // Register cluster
+                 tseed.SetX(iTime,dxlayer);     // Register cluster
+                 tseed.SetY(iTime,clu->GetY()); // Register cluster
+                 tseed.SetZ(iTime,clu->GetZ()); // Register cluster
+
+               }
+
+               tseed.Update();
+               if (tseed.IsOK()) {
+                 Float_t  dangle   = tseed.GetYfit(1) - tseed.GetYref(1);
+                 Double_t zcor     = tseed.GetTilt() * (tseed.GetZProb() - tseed.GetZref(0));
+                 Float_t  tquality = (18.0 - tseed.GetN2()) / 2.0 
+                                    + TMath::Abs(dangle)     / 0.1
+                                    + TMath::Abs(tseed.GetYfit(0) - (tseed.GetYref(0) - zcor)) / 0.2
+                                    + 2.0 * TMath::Abs(tseed.GetMeanz() - tseed.GetZref(0))    / padlength[jLayer];
+                 if (tquality<squality[bLayer]) {
+                   bseed[bLayer] = tseed;
+                 }
+               }
+
+             } // Loop: jLayer
+
+             chi2 = AliTRDseed::FitRiemanTilt(bseed,kTRUE);
+
+           } // Loop: jter
+
+           nclusters = 0;
+           nlayers   = 0;
+           findable  = 0;
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             if (TMath::Abs(cseed[iLayer].GetYref(0) / cseed[iLayer].GetX0()) < 0.15) {
+               findable++;
+             }
+             if (cseed[iLayer].IsOK()) {
+               nclusters += cseed[iLayer].GetN2();         
+               nlayers++;
+             }
+           }
+           if (nlayers < 3) {
+              continue;
+           }
+           rieman.Reset();
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             if (cseed[iLayer].IsOK()) {
+                rieman.AddPoint(xcl[iLayer]
+                              ,cseed[iLayer].GetYfitR(0)
+                              ,cseed[iLayer].GetZProb()
+                               ,1
+                               ,10);
+             }
+           }
+           rieman.Update();
+
+           chi2RF = 0.0;
+           chi2ZF = 0.0;
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             if (cseed[iLayer].IsOK()) {
+               cseed[iLayer].SetYref(0,rieman.GetYat(xcl[iLayer]));
+               chi2RF += (cseed[iLayer].GetYref(0) - cseed[iLayer].GetYfitR(0))
+                        * (cseed[iLayer].GetYref(0) - cseed[iLayer].GetYfitR(0));
+               cseed[iLayer].SetYref(1,rieman.GetDYat(xcl[iLayer]));
+               cseed[iLayer].SetZref(0,rieman.GetZat(xcl[iLayer]));
+               chi2ZF += (cseed[iLayer].GetZref(0) - cseed[iLayer].GetMeanz())
+                        * (cseed[iLayer].GetZref(0) - cseed[iLayer].GetMeanz());
+               cseed[iLayer].SetZref(1,rieman.GetDZat(xcl[iLayer]));
+             }
+           }
+           chi2RF /= TMath::Max((nlayers - 3.0),1.0);
+           chi2ZF /= TMath::Max((nlayers - 3.0),1.0);
+           curv    = rieman.GetC();
+
+           Double_t xref2 = (xcl[2] + xcl[3]) * 0.5; // Middle of the chamber
+           Double_t dzmf  = rieman.GetDZat(xref2);
+           Double_t zmf   = rieman.GetZat(xref2);
+
+           //
+           // Fit hyperplane
+           //
+           Int_t npointsT = 0;
+           fitterTC.ClearPoints();
+           fitterT2.ClearPoints();
+           rieman2.Reset();
+
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+
+             if (!cseed[iLayer].IsOK()) {
+                continue;
+             }
+
+             for (Int_t itime = 0; itime < 25; itime++) {
+
+               if (!cseed[iLayer].IsUsable(itime)) {
+                  continue;
+               }
+                // X relative to the middle chamber
+               Double_t x  = cseed[iLayer].GetX(itime) + cseed[iLayer].GetX0() - xref2;  
+               Double_t y  = cseed[iLayer].GetY(itime);
+               Double_t z  = cseed[iLayer].GetZ(itime);
+               // ExB correction to the correction
+               // Tilted rieman
+               Double_t uvt[6];
+                // Global x
+               Double_t x2 = cseed[iLayer].GetX(itime) + cseed[iLayer].GetX0();      
+               Double_t t  = 1.0 / (x2*x2 + y*y);
+               uvt[1] = t;                 // t
+               uvt[0] = 2.0 * x2 * uvt[1]; // u 
+               uvt[2] = 2.0 * hL[iLayer] * uvt[1];
+               uvt[3] = 2.0 * hL[iLayer] * x * uvt[1];       
+               uvt[4] = 2.0 * (y + hL[iLayer]*z) * uvt[1];
+               Double_t error = 2.0 * 0.2 * uvt[1];
+               fitterT2.AddPoint(uvt,uvt[4],error);
+
+               //
+               // Constrained rieman
+               // 
+               z = cseed[iLayer].GetZ(itime);
+               uvt[0] = 2.0 * x2 * t; // u 
+               uvt[1] = 2.0 * hL[iLayer] * x2 * uvt[1];              
+               uvt[2] = 2.0 * (y + hL[iLayer] * (z - GetZ())) * t;
+               fitterTC.AddPoint(uvt,uvt[2],error);
+               rieman2.AddPoint(x2,y,z,1,10);
+               npointsT++;
+
+             }
+
+           } // Loop: iLayer
+
+           rieman2.Update();
+           fitterTC.Eval();
+           fitterT2.Eval();
+           Double_t rpolz0 = fitterT2.GetParameter(3);
+           Double_t rpolz1 = fitterT2.GetParameter(4);     
+
+           //
+           // Linear fitter  - not possible to make boundaries
+           // Do not accept non possible z and dzdx combinations
+           //      
+           Bool_t acceptablez = kTRUE;
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             if (cseed[iLayer].IsOK()) {
+               Double_t zT2 = rpolz0 + rpolz1 * (xcl[iLayer] - xref2);
+               if (TMath::Abs(cseed[iLayer].GetZProb() - zT2) > padlength[iLayer] * 0.5 + 1.0) {
+                 acceptablez = kFALSE;
+               }
+             }
+           }
+           if (!acceptablez) {
+             fitterT2.FixParameter(3,zmf);
+             fitterT2.FixParameter(4,dzmf);
+             fitterT2.Eval();
+             fitterT2.ReleaseParameter(3);
+             fitterT2.ReleaseParameter(4);
+             rpolz0 = fitterT2.GetParameter(3);
+             rpolz1 = fitterT2.GetParameter(4);
+           }
+
+           Double_t chi2TR = fitterT2.GetChisquare() / Float_t(npointsT);
+           Double_t chi2TC = fitterTC.GetChisquare() / Float_t(npointsT);
+           Double_t polz1c = fitterTC.GetParameter(2);
+           Double_t polz0c = polz1c * xref2;
+           Double_t aC     =  fitterTC.GetParameter(0);
+           Double_t bC     =  fitterTC.GetParameter(1);
+           Double_t cC     =  aC / TMath::Sqrt(bC * bC + 1.0); // Curvature
+           Double_t aR     =  fitterT2.GetParameter(0);
+           Double_t bR     =  fitterT2.GetParameter(1);
+           Double_t dR     =  fitterT2.GetParameter(2);            
+           Double_t cR     =  1.0 + bR*bR - dR*aR;
+           Double_t dca    =  0.0;         
+           if (cR > 0.0) {
+             dca = -dR / (TMath::Sqrt(1.0 + bR*bR - dR*aR) + TMath::Sqrt(1.0 + bR*bR)); 
+             cR  =  aR / TMath::Sqrt(cR);
+           }
+
+           Double_t chi2ZT2 = 0.0;
+            Double_t chi2ZTC = 0.0;
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             if (cseed[iLayer].IsOK()) {
+               Double_t zT2 = rpolz0 + rpolz1 * (xcl[iLayer] - xref2);
+               Double_t zTC = polz0c + polz1c * (xcl[iLayer] - xref2);
+               chi2ZT2 += TMath::Abs(cseed[iLayer].GetMeanz() - zT2);
+               chi2ZTC += TMath::Abs(cseed[iLayer].GetMeanz() - zTC);
+             }
+           }
+           chi2ZT2 /= TMath::Max((nlayers - 3.0),1.0);
+           chi2ZTC /= TMath::Max((nlayers - 3.0),1.0);     
+
+           AliTRDseed::FitRiemanTilt(cseed,kTRUE);
+           Float_t sumdaf = 0.0;
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             if (cseed[iLayer].IsOK()) {
+               sumdaf += TMath::Abs((cseed[iLayer].GetYfit(1) - cseed[iLayer].GetYref(1))
+                                    / cseed[iLayer].GetSigmaY2());
+             }
+           }
+           sumdaf /= Float_t (nlayers - 2.0);
+
+           //
+           // Likelihoods for full track
+           //
+           Double_t likezf     = TMath::Exp(-chi2ZF * 0.14);
+           Double_t likechi2C  = TMath::Exp(-chi2TC * 0.677);
+           Double_t likechi2TR = TMath::Exp(-chi2TR * 0.78);
+           Double_t likeaf     = TMath::Exp(-sumdaf * 3.23);
+           seedquality2[registered] = likezf * likechi2TR * likeaf; 
+
+           // Still needed ????
+//         Bool_t isGold = kFALSE;
+//         
+//         if (nlayers == 6        && TMath::Log(0.000000001+seedquality2[index])<-5.) isGold =kTRUE;   // gold
+//         if (nlayers == findable && TMath::Log(0.000000001+seedquality2[index])<-4.) isGold =kTRUE;   // gold
+//         if (isGold &&nusedf<10){
+//           for (Int_t jLayer=0;jLayer<6;jLayer++){
+//             if ( seed[index][jLayer].IsOK()&&TMath::Abs(seed[index][jLayer].fYfit[1]-seed[index][jLayer].fYfit[1])<0.1)
+//               seed[index][jLayer].UseClusters();  //sign gold
+//           }
+//         }
+
+           Int_t index0 = 0;
+           if (!cseed[0].IsOK()) {
+             index0 = 1;
+             if (!cseed[1].IsOK()) {
+                index0 = 2;
+             }
+           }
+           seedparams[registered][0] = cseed[index0].GetX0();
+           seedparams[registered][1] = cseed[index0].GetYref(0);
+           seedparams[registered][2] = cseed[index0].GetZref(0);
+           seedparams[registered][5] = cR;
+           seedparams[registered][3] = cseed[index0].GetX0() * cR - TMath::Sin(TMath::ATan(cseed[0].GetYref(1)));
+           seedparams[registered][4] = cseed[index0].GetZref(1)
+                                      /        TMath::Sqrt(1.0 + cseed[index0].GetYref(1) * cseed[index0].GetYref(1));
+           seedparams[registered][6] = ns;
+
+           Int_t labels[12];
+            Int_t outlab[24];
+           Int_t nlab = 0;
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             if (!cseed[iLayer].IsOK()) {
+                continue;
+             }
+             if (cseed[iLayer].GetLabels(0) >= 0) {
+               labels[nlab] = cseed[iLayer].GetLabels(0);
+               nlab++;
+             }
+             if (cseed[iLayer].GetLabels(1) >= 0) {
+               labels[nlab] = cseed[iLayer].GetLabels(1);
+               nlab++;
+             }
+           }
+           Freq(nlab,labels,outlab,kFALSE);
+           Int_t label     = outlab[0];
+           Int_t frequency = outlab[1];
+           for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+             cseed[iLayer].SetFreq(frequency);
+             cseed[iLayer].SetC(cR);
+             cseed[iLayer].SetCC(cC);
+             cseed[iLayer].SetChi2(chi2TR);
+             cseed[iLayer].SetChi2Z(chi2ZF);
+           }
+
+           // Debugging print
+           if (1 || (!isFake)) {
+             Float_t zvertex = GetZ();
+             TTreeSRedirector &cstream = *fDebugStreamer;
+             if (fReconstructor->GetStreamLevel(AliTRDReconstructor::kTracker) > 0) {
+               cstream << "Seeds1"
+                       << "isFake="     << isFake
+                       << "Vertex="     << zvertex
+                       << "Rieman2.="   << &rieman2
+                       << "Rieman.="    << &rieman
+                       << "Xref="       << xref
+                       << "X0="         << xcl[0]
+                       << "X1="         << xcl[1]
+                       << "X2="         << xcl[2]
+                       << "X3="         << xcl[3]
+                       << "X4="         << xcl[4]
+                       << "X5="         << xcl[5]
+                       << "Chi2R="      << chi2R
+                       << "Chi2Z="      << chi2Z
+                       << "Chi2RF="     << chi2RF  // Chi2 of trackletes on full track
+                       << "Chi2ZF="     << chi2ZF  // Chi2 z on tracklets on full track
+                       << "Chi2ZT2="    << chi2ZT2 // Chi2 z on tracklets on full track  - rieman tilt
+                       << "Chi2ZTC="    << chi2ZTC // Chi2 z on tracklets on full track  - rieman tilt const
+                       << "Chi2TR="     << chi2TR  // Chi2 without vertex constrain
+                       << "Chi2TC="     << chi2TC  // Chi2 with    vertex constrain
+                       << "C="          << curv    // Non constrained - no tilt correction
+                       << "DR="         << dR      // DR parameter    - tilt correction
+                       << "DCA="        << dca     // DCA             - tilt correction
+                       << "CR="         << cR      // Non constrained curvature - tilt correction
+                       << "CC="         << cC      // Constrained curvature
+                       << "Polz0="      << polz0c
+                       << "Polz1="      << polz1c
+                       << "RPolz0="     << rpolz0
+                       << "RPolz1="     << rpolz1
+                       << "Ncl="        << nclusters
+                       << "Nlayers="    << nlayers
+                       << "NUsedS="     << nusedCl
+                       << "NUsed="      << nusedf
+                       << "Findable="   << findable
+                       << "Like="       << like
+                       << "LikePrim="   << likePrim
+                       << "Likechi2C="  << likechi2C
+                       << "Likechi2TR=" << likechi2TR
+                       << "Likezf="     << likezf
+                       << "LikeF="      << seedquality2[registered]
+                       << "S0.="        << &cseed[0]
+                       << "S1.="        << &cseed[1]
+                       << "S2.="        << &cseed[2]
+                       << "S3.="        << &cseed[3]
+                       << "S4.="        << &cseed[4]
+                       << "S5.="        << &cseed[5]
+                       << "SB0.="       << &seedb[0]
+                       << "SB1.="       << &seedb[1]
+                       << "SB2.="       << &seedb[2]
+                       << "SB3.="       << &seedb[3]
+                       << "SB4.="       << &seedb[4]
+                       << "SB5.="       << &seedb[5]
+                       << "Label="      << label
+                       << "Freq="       << frequency
+                       << "sLayer="     << sLayer
+                       << "\n";
+             }
+           }
+
+           if (registered<kMaxSeed - 1) {
+             registered++;
+             cseed = seed[registered];
+           }
+
+         } // End of loop over layer 1
+
+       } // End of loop over layer 0 
+
+      } // End of loop over layer 3     
+
+    } // End of loop over seeding time bins 
+
+    //
+    // Choose best
+    //
 
-  return 0;
-}
+    TMath::Sort(registered,seedquality2,sort,kTRUE);
+    Bool_t signedseed[kMaxSeed];
+    for (Int_t i = 0; i < registered; i++) {
+      signedseed[i] = kFALSE;
+    }
 
-//______________________________________________________________________
-void AliTRDtracker::ReadClusters(TObjArray *array, const Char_t *filename)
-{
-  //
-  // Reads AliTRDclusters from file <filename>. The names of the cluster
-  // tree and branches should match the ones used in
-  // AliTRDclusterizer::WriteClusters()
-  // if <array> == 0, clusters are added into AliTRDtracker fCluster array
-  //
+    for (Int_t jter = 0; jter < 5; jter++) {
 
-  TDirectory *savedir=gDirectory;
+      for (Int_t iseed = 0; iseed < registered; iseed++) {
+      
+       Int_t index = sort[iseed];
+       if (signedseed[index]) {
+          continue;
+       }
+       Int_t labelsall[1000];
+       Int_t nlabelsall = 0;
+       Int_t naccepted  = 0;;
+       Int_t sLayer     = seedlayer[index];
+       Int_t ncl        = 0;
+       Int_t nused      = 0;
+       Int_t nlayers    = 0;
+       Int_t findable   = 0;
+
+       for (Int_t jLayer = 0; jLayer < 6; jLayer++) {
+
+         if (TMath::Abs(seed[index][jLayer].GetYref(0) / xcl[jLayer]) < 0.15) {
+           findable++;
+         }
+         if (seed[index][jLayer].IsOK()) {
+           seed[index][jLayer].UpdateUsed();
+           ncl   +=seed[index][jLayer].GetN2();
+           nused +=seed[index][jLayer].GetNUsed();
+           nlayers++;
+           // Cooking label
+           for (Int_t itime = 0; itime < 25; itime++) {
+             if (seed[index][jLayer].IsUsable(itime)) {
+               naccepted++;
+               for (Int_t ilab = 0; ilab < 3; ilab++) {
+                 Int_t tindex = seed[index][jLayer].GetClusters(itime)->GetLabel(ilab);
+                 if (tindex >= 0) {
+                   labelsall[nlabelsall] = tindex;
+                   nlabelsall++;
+                 }
+               }
+             }
+           }
+         }
 
-  TFile *file = TFile::Open(filename);
-  if (!file->IsOpen()) {
-    cerr<<"Can't open file with TRD clusters"<<endl;
-    return;
-  }
+       }
 
-  Char_t treeName[12];
-  sprintf(treeName,"TreeR%d_TRD",GetEventNumber());
-  TTree *clusterTree = (TTree*) gDirectory->Get(treeName);
+       if (nused > 30) {
+          continue;
+       }
 
-  if (!clusterTree) {
-     cerr<<"AliTRDtracker::ReadClusters(): ";
-     cerr<<"can't get a tree with clusters !\n";
-     return;
-  }
+       if (jter == 0) {
+         if (nlayers < 6) {
+            continue;
+         }
+         if (TMath::Log(0.000000001+seedquality2[index]) < -5.0) {
+            continue; // Gold
+         }
+       }
 
-  TObjArray *clusterArray = new TObjArray(400);
+       if (jter == 1) {
+         if (nlayers < findable) {
+            continue;
+         }
+         if (TMath::Log(0.000000001+seedquality2[index]) < -4.0) {
+            continue;
+         }
+       }
 
-  clusterTree->GetBranch("TRDcluster")->SetAddress(&clusterArray);
+       if (jter == 2) {
+         if ((nlayers == findable) || 
+              (nlayers ==        6)) {
+            continue;
+         }
+         if (TMath::Log(0.000000001+seedquality2[index]) < -6.0) {
+            continue;
+         }
+       }
 
-  Int_t nEntries = (Int_t) clusterTree->GetEntries();
-  cout<<"found "<<nEntries<<" in clusterTree"<<endl;   
+       if (jter == 3) {
+         if (TMath::Log(0.000000001+seedquality2[index]) < -5.0) {
+            continue;
+         }
+       }
 
-  // Loop through all entries in the tree
-  Int_t nbytes = 0;
-  AliTRDcluster *c = 0;
+       if (jter == 4) {
+         if (TMath::Log(0.000000001+seedquality2[index]) - nused/(nlayers-3.0) < -15.0) {
+            continue;
+         }
+       }
 
-  //  printf("\n");
+       signedseed[index] = kTRUE;
+
+       Int_t labels[1000];
+        Int_t outlab[1000];
+       Int_t nlab = 0;
+       for (Int_t iLayer = 0; iLayer < 6; iLayer++) {
+         if (seed[index][iLayer].IsOK()) {
+           if (seed[index][iLayer].GetLabels(0) >= 0) {
+             labels[nlab] = seed[index][iLayer].GetLabels(0);
+             nlab++;
+           }
+           if (seed[index][iLayer].GetLabels(1) >= 0) {
+             labels[nlab] = seed[index][iLayer].GetLabels(1);
+             nlab++;
+           }
+         }   
+       }
+       Freq(nlab,labels,outlab,kFALSE);
+       Int_t   label     = outlab[0];
+       Int_t   frequency = outlab[1];
+       Freq(nlabelsall,labelsall,outlab,kFALSE);
+       Int_t   label1    = outlab[0];
+       Int_t   label2    = outlab[2];
+       Float_t fakeratio = (naccepted - outlab[1]) / Float_t(naccepted);
+       Float_t ratio     = Float_t(nused) / Float_t(ncl);
+       if (ratio < 0.25) {
+         for (Int_t jLayer = 0; jLayer < 6; jLayer++) {
+           if ((seed[index][jLayer].IsOK()) && 
+                (TMath::Abs(seed[index][jLayer].GetYfit(1) - seed[index][jLayer].GetYfit(1)) < 0.2)) {
+             seed[index][jLayer].UseClusters(); // Sign gold
+           }
+         }
+       }
 
-  for (Int_t iEntry = 0; iEntry < nEntries; iEntry++) {
+       Int_t eventNrInFile = esd->GetEventNumberInFile(); // This is most likely NOT the event number you'd like to use. It has nothing to do with the 'real' event number.
+       TTreeSRedirector &cstream = *fDebugStreamer;
 
-    // Import the tree
-    nbytes += clusterTree->GetEvent(iEntry);
+       //
+       // Register seed
+       //
+       AliTRDtrack *track = RegisterSeed(seed[index],seedparams[index]);
+       AliTRDtrack  dummy;
+       if (!track) {
+          track = &dummy;
+       }
+       else {
+         AliESDtrack esdtrack;
+         esdtrack.UpdateTrackParams(track,AliESDtrack::kTRDout);
+         esdtrack.SetLabel(label);
+         esd->AddTrack(&esdtrack);     
+         if (fReconstructor->GetStreamLevel(AliTRDReconstructor::kTracker) > 0) {
+           cstream << "Tracks"
+                   << "EventNrInFile="  << eventNrInFile
+                   << "ESD.="     << &esdtrack
+                   << "trd.="     << track
+                   << "trdback.=" << track
+                   << "\n";
+         }
+       }
 
-    // Get the number of points in the detector
-    Int_t nCluster = clusterArray->GetEntriesFast();
-    //    printf("\n Read %d clusters from entry %d", nCluster, iEntry);
+       if (fReconstructor->GetStreamLevel(AliTRDReconstructor::kTracker) > 0) {
+         cstream << "Seeds2"
+                 << "Iter="      << jter
+                 << "Track.="    << track
+                 << "Like="      << seedquality[index]
+                 << "LikeF="     << seedquality2[index]
+                 << "S0.="       << &seed[index][0]
+                 << "S1.="       << &seed[index][1]
+                 << "S2.="       << &seed[index][2]
+                 << "S3.="       << &seed[index][3]
+                 << "S4.="       << &seed[index][4]
+                 << "S5.="       << &seed[index][5]
+                 << "Label="     << label
+                 << "Label1="    << label1
+                 << "Label2="    << label2
+                 << "FakeRatio=" << fakeratio
+                 << "Freq="      << frequency
+                 << "Ncl="       << ncl
+                 << "Nlayers="   << nlayers
+                 << "Findable="  << findable
+                 << "NUsed="     << nused
+                 << "sLayer="    << sLayer
+                 << "EventNrInFile="   << eventNrInFile
+                 << "\n";
+       }
 
-    // Loop through all TRD digits
-    for (Int_t iCluster = 0; iCluster < nCluster; iCluster++) {
-      c = (AliTRDcluster*)clusterArray->UncheckedAt(iCluster);
-      AliTRDcluster *co = new AliTRDcluster(*c);
-      co->SetSigmaY2(c->GetSigmaY2() * fSY2corr);
-      Int_t ltb = co->GetLocalTimeBin();
-      if(ltb == 19) co->SetSigmaZ2(c->GetSigmaZ2());
-      else if(fNoTilt) co->SetSigmaZ2(c->GetSigmaZ2() * fSZ2corr);
-      array->AddLast(co);
-      delete clusterArray->RemoveAt(iCluster);
-    }
-  }
+      } // Loop: iseed
 
-  file->Close();
-  delete clusterArray;
-  savedir->cd();
+    } // Loop: jter
 
-}                      
+  } // End of loop over sectors
 
-void AliTRDtracker::ReadClusters(TObjArray *array, const TFile *inp) 
+  delete [] pseed;
+
+       return 0;
+}
+          
+//_____________________________________________________________________________
+Int_t AliTRDtracker::ReadClusters(TObjArray *array, TTree *clusterTree) const
 {
   //
-  // Reads AliTRDclusters (option >= 0) or AliTRDrecPoints (option < 0) 
-  // from the file. The names of the cluster tree and branches 
+  // Reads AliTRDclusters from the file. 
+  // The names of the cluster tree and branches 
   // should match the ones used in AliTRDclusterizer::WriteClusters()
   //
 
-  TDirectory *savedir=gDirectory; 
-
-  if (inp) {
-     TFile *in=(TFile*)inp;
-     if (!in->IsOpen()) {
-        cerr<<"AliTRDtracker::ReadClusters(): input file is not open !\n";
-        return;
-     }
-     else{
-       in->cd();
-     }
-  }
-
-  Char_t treeName[12];
-  sprintf(treeName,"TreeR%d_TRD",GetEventNumber());
-  TTree *clusterTree = (TTree*) gDirectory->Get(treeName);
-  
-  TObjArray *clusterArray = new TObjArray(400); 
+  Int_t nsize = Int_t(clusterTree->GetTotBytes() / (sizeof(AliTRDcluster))); 
+  TObjArray *clusterArray = new TObjArray(nsize+1000); 
   
-  clusterTree->GetBranch("TRDcluster")->SetAddress(&clusterArray); 
-  
-  Int_t nEntries = (Int_t) clusterTree->GetEntries();
-  //  printf("found %d entries in %s.\n",nEntries,clusterTree->GetName());
+  TBranch *branch = clusterTree->GetBranch("TRDcluster");
+  if (!branch) {
+    AliError("Can't get the branch !");
+    return 1;
+  }
+  branch->SetAddress(&clusterArray); 
   
   // Loop through all entries in the tree
-  Int_t nbytes = 0;
-  AliTRDcluster *c = 0;
-  //  printf("\n");
-
+  Int_t nEntries   = (Int_t) clusterTree->GetEntries();
+  Int_t nbytes     = 0;
+  AliTRDcluster *c = 0x0;
   for (Int_t iEntry = 0; iEntry < nEntries; iEntry++) {    
     
     // Import the tree
@@ -2279,70 +2499,122 @@ void AliTRDtracker::ReadClusters(TObjArray *array, const TFile *inp)
     
     // Get the number of points in the detector
     Int_t nCluster = clusterArray->GetEntriesFast();  
-//    printf("\r Read %d clusters from entry %d", nCluster, iEntry);
-    
     // Loop through all TRD digits
     for (Int_t iCluster = 0; iCluster < nCluster; iCluster++) { 
-      c = (AliTRDcluster*)clusterArray->UncheckedAt(iCluster);
-      AliTRDcluster *co = new AliTRDcluster(*c);
-      co->SetSigmaY2(c->GetSigmaY2() * fSY2corr);
-      Int_t ltb = co->GetLocalTimeBin();
-      if(ltb == 19) co->SetSigmaZ2(c->GetSigmaZ2());
-      else if(fNoTilt) co->SetSigmaZ2(c->GetSigmaZ2() * fSZ2corr);
-      array->AddLast(co);
-      delete clusterArray->RemoveAt(iCluster); 
+      if(!(c = (AliTRDcluster *) clusterArray->UncheckedAt(iCluster))) continue;
+      array->AddLast(c);
+                       //printf("Add cluster 0x%x.\n", c);
+      clusterArray->RemoveAt(iCluster); 
     }
-  }
 
+  }
   delete clusterArray;
-  savedir->cd();   
+
+  return 0;
+
+}
+
+//_____________________________________________________________________________
+Bool_t AliTRDtracker::GetTrackPoint(Int_t index, AliTrackPoint &p) const
+{
+  //
+  // Get track space point with index i
+  // Origin: C.Cheshkov
+  //
+
+  AliTRDcluster *cl = (AliTRDcluster *) fClusters->UncheckedAt(index);
+  Int_t  idet    = cl->GetDetector();
+  Int_t  isector = fGeom->GetSector(idet);
+  Int_t  istack  = fGeom->GetStack(idet);
+  Int_t  ilayer  = fGeom->GetLayer(idet);
+  Double_t local[3];
+  local[0] = GetX(isector,ilayer,cl->GetLocalTimeBin());
+  local[1] = cl->GetY();
+  local[2] = cl->GetZ();
+  Double_t global[3];
+  fGeom->RotateBack(idet,local,global);
+  p.SetXYZ(global[0],global[1],global[2]);
+  AliGeomManager::ELayerID iGeoLayer = AliGeomManager::kTRD1;
+  switch (ilayer) {
+  case 0:
+    iGeoLayer = AliGeomManager::kTRD1;
+    break;
+  case 1:
+    iGeoLayer = AliGeomManager::kTRD2;
+    break;
+  case 2:
+    iGeoLayer = AliGeomManager::kTRD3;
+    break;
+  case 3:
+    iGeoLayer = AliGeomManager::kTRD4;
+    break;
+  case 4:
+    iGeoLayer = AliGeomManager::kTRD5;
+    break;
+  case 5:
+    iGeoLayer = AliGeomManager::kTRD6;
+    break;
+  };
+  Int_t    modId = isector * fGeom->Nstack() + istack;
+  UShort_t volid = AliGeomManager::LayerToVolUID(iGeoLayer,modId);
+  p.SetVolumeID(volid);
+
+  return kTRUE;
 
 }
 
-//__________________________________________________________________
-void AliTRDtracker::CookLabel(AliKalmanTrackpt, Float_t wrong) const 
+//_____________________________________________________________________________
+void AliTRDtracker::CookLabel(AliKalmanTrack *pt, Float_t wrong) const 
 {
   //
   // This cooks a label. Mmmmh, smells good...
   //
 
-  Int_t label=123456789, index, i, j;
-  Int_t ncl=pt->GetNumberOfClusters();
-  const Int_t kRange = fTrSec[0]->GetOuterTimeBin()+1;
+  Int_t label = 123456789;
+  Int_t index;
+  Int_t i;
+  Int_t j;
+  Int_t ncl   = pt->GetNumberOfClusters();
+
+  const Int_t kRange = fTrSec[0]->GetOuterTimeBin() + 1;
 
   Bool_t labelAdded;
 
-  //  Int_t s[kRange][2];
   Int_t **s = new Int_t* [kRange];
-  for (i=0; i<kRange; i++) {
+  for (i = 0; i < kRange; i++) {
     s[i] = new Int_t[2];
   }
-  for (i=0; i<kRange; i++) {
-    s[i][0]=-1;
-    s[i][1]=0;
+  for (i = 0; i < kRange; i++) {
+    s[i][0] = -1;
+    s[i][1] =  0;
   }
 
-  Int_t t0,t1,t2;
-  for (i=0; i<ncl; i++) {
-    index=pt->GetClusterIndex(i);
-    AliTRDcluster *c=(AliTRDcluster*)fClusters->UncheckedAt(index);
+  Int_t t0;
+  Int_t t1;
+  Int_t t2;
+
+  for (i = 0; i < ncl; i++) {
+    index = pt->GetClusterIndex(i);
+    AliTRDcluster *c = (AliTRDcluster *) fClusters->UncheckedAt(index);
     t0=c->GetLabel(0);
     t1=c->GetLabel(1);
     t2=c->GetLabel(2);
   }
 
-  for (i=0; i<ncl; i++) {
-    index=pt->GetClusterIndex(i);
-    AliTRDcluster *c=(AliTRDcluster*)fClusters->UncheckedAt(index);
-    for (Int_t k=0; k<3; k++) { 
-      label=c->GetLabel(k);
-      labelAdded=kFALSE; j=0;
+  for (i = 0; i < ncl; i++) {
+    index = pt->GetClusterIndex(i);
+    AliTRDcluster *c = (AliTRDcluster *) fClusters->UncheckedAt(index);
+    for (Int_t k = 0; k < 3; k++) { 
+      label      = c->GetLabel(k);
+      labelAdded = kFALSE; 
+      j = 0;
       if (label >= 0) {
-        while ( (!labelAdded) && ( j < kRange ) ) {
-          if (s[j][0]==label || s[j][1]==0) {
-            s[j][0]=label; 
-            s[j][1]=s[j][1]+1; 
-            labelAdded=kTRUE;
+        while ((!labelAdded) && (j < kRange)) {
+          if ((s[j][0] == label) || 
+              (s[j][1] ==     0)) {
+            s[j][0] = label; 
+            s[j][1] = s[j][1] + 1; 
+            labelAdded = kTRUE;
           }
           j++;
         }
@@ -2350,63 +2622,85 @@ void AliTRDtracker::CookLabel(AliKalmanTrack* pt, Float_t wrong) const
     }
   }
 
-  Int_t max=0;
+  Int_t max = 0;
   label = -123456789;
 
-  for (i=0; i<kRange; i++) {
-    if (s[i][1]>max) {
-      max=s[i][1]; label=s[i][0];
+  for (i = 0; i < kRange; i++) {
+    if (s[i][1] > max) {
+      max   = s[i][1]; 
+      label = s[i][0];
     }
   }
 
-  for (i=0; i<kRange; i++) {
+  for (i = 0; i < kRange; i++) {
     delete []s[i];
   }        
 
   delete []s;
 
-  if ((1.- Float_t(max)/ncl) > wrong) label=-label;   
+  if ((1.0 - Float_t(max)/ncl) > wrong) {
+    label = -label;   
+  }
 
   pt->SetLabel(label); 
 
 }
 
-
-//__________________________________________________________________
-void AliTRDtracker::UseClusters(const AliKalmanTrack* t, Int_t from) const 
+//_____________________________________________________________________________
+void AliTRDtracker::UseClusters(const AliKalmanTrack *t, Int_t from) const 
 {
   //
   // Use clusters, but don't abuse them!
   //
 
-  Int_t ncl=t->GetNumberOfClusters();
-  for (Int_t i=from; i<ncl; i++) {
-    Int_t index = t->GetClusterIndex(i);
-    AliTRDcluster *c=(AliTRDcluster*)fClusters->UncheckedAt(index);
-    c->Use();
+  const Float_t kmaxchi2 = 18;
+  const Float_t kmincl   = 10;
+
+  AliTRDtrack *track = (AliTRDtrack *) t;
+
+  Int_t ncl = t->GetNumberOfClusters();
+  for (Int_t i = from; i < ncl; i++) {
+    Int_t index  = t->GetClusterIndex(i);
+    AliTRDcluster *c = (AliTRDcluster *) fClusters->UncheckedAt(index);
+    Int_t ilayer = fGeom->GetLayer(c->GetDetector());
+    if (track->GetTracklets(ilayer).GetChi2() > kmaxchi2) {
+      continue; 
+    }
+    if (track->GetTracklets(ilayer).GetN()    <   kmincl) {
+      continue; 
+    }
+    if (!(c->IsUsed())) {
+      c->Use();
+    }
   }
-}
 
+}
 
-//_____________________________________________________________________
+//_____________________________________________________________________________
 Double_t AliTRDtracker::ExpectedSigmaY2(Double_t , Double_t , Double_t ) const
 {
+  //
   // Parametrised "expected" error of the cluster reconstruction in Y 
+  //
 
   Double_t s = 0.08 * 0.08;    
   return s;
+
 }
 
-//_____________________________________________________________________
+//_____________________________________________________________________________
 Double_t AliTRDtracker::ExpectedSigmaZ2(Double_t , Double_t ) const
 {
+  //
   // Parametrised "expected" error of the cluster reconstruction in Z 
+  //
 
-  Double_t s = 9 * 9 /12.;  
+  Double_t s = 9.0 * 9.0 / 12.0;  
   return s;
+
 }                  
 
-//_____________________________________________________________________
+//_____________________________________________________________________________
 Double_t AliTRDtracker::GetX(Int_t sector, Int_t plane, Int_t localTB) const 
 {
   //
@@ -2415,667 +2709,1247 @@ Double_t AliTRDtracker::GetX(Int_t sector, Int_t plane, Int_t localTB) const
   //
 
   Int_t index = fTrSec[sector]->CookTimeBinIndex(plane, localTB); 
-  Int_t pl = fTrSec[sector]->GetLayerNumber(index);
+  Int_t pl    = fTrSec[sector]->GetLayerNumber(index);
+
   return fTrSec[sector]->GetLayer(pl)->GetX();
 
 }
 
 
-//_______________________________________________________
-AliTRDtracker::AliTRDpropagationLayer::AliTRDpropagationLayer(Double_t x, 
-               Double_t dx, Double_t rho, Double_t radLength, Int_t tbIndex)
-{ 
+//_____________________________________________________________________________
+AliTRDtracker::AliTRDtrackingSector
+             ::AliTRDtrackingSector(AliTRDgeometry *geo, Int_t gs)
+  :fN(0)
+  ,fGeom(geo)
+  ,fGeomSector(gs)
+{
+  //
+  // AliTRDtrackingSector Constructor
+  //
+
+  AliTRDpadPlane *padPlane = 0;
+  AliTRDpropagationLayer *ppl = 0;
+
+  // Get holes description from geometry
+  Bool_t holes[AliTRDgeometry::kNstack];
+  for (Int_t istack = 0; istack < AliTRDgeometry::kNstack; istack++) {
+    holes[istack] = fGeom->IsHole(0,istack,gs);
+  } 
+  
+  for (UInt_t i = 0; i < kMaxTimeBinIndex; i++) {
+    fTimeBinIndex[i] = -1;
+  }
+
+  Double_t x;
+  Double_t dx;
+  Double_t rho;
+  Double_t radLength;
+
+  // Add layers for each of the planes
+  Double_t dxAmp   = (Double_t) fGeom->CamHght(); // Amplification region
+  //Double_t dxDrift = (Double_t) fGeom->CdrHght(); // Drift region  
+
+  const Int_t kNstacks  = AliTRDgeometry::Nstack();
+  Int_t    tbIndex;
+  Double_t ymax           = 0;
+  Double_t ymaxsensitive  = 0;
+  Double_t *zc            = new Double_t[kNstacks];
+  Double_t *zmax          = new Double_t[kNstacks];
+  Double_t *zmaxsensitive = new Double_t[kNstacks];  
+    
+  for (Int_t layer = 0; layer < AliTRDgeometry::Nlayer(); layer++) {
+
+    ymax          = fGeom->GetChamberWidth(layer) / 2.0;
+    padPlane      = fGeom->GetPadPlane(layer,0);
+    ymaxsensitive = (padPlane->GetColSize(1) * padPlane->GetNcols() - 4.0) / 2.0;    
+
+    for (Int_t st = 0; st < kNstacks; st++) {
+      zmax[st]          = fGeom->GetChamberLength(layer,st) / 2.0;
+      Float_t pad       = padPlane->GetRowSize(1);
+      Float_t row0      = fGeom->GetRow0(layer,st,0);
+      Int_t   nPads     = fGeom->GetRowMax(layer,st,0);
+      zmaxsensitive[st] = Float_t(nPads) * pad / 2.0;      
+      zc[st]            = -(pad * nPads) / 2.0 + row0;
+    }
+
+               AliTRDcalibDB *fCalibration = AliTRDcalibDB::Instance();
+    dx        = fCalibration->GetVdrift(0,0,0)
+              / AliTRDCommonParam::Instance()->GetSamplingFrequency();
+    rho       = 0.00295 * 0.85; //????
+    radLength = 11.0;  
+
+    Double_t x0 = (Double_t) AliTRDgeometry::GetTime0(layer);
+    //Double_t xbottom = x0 - dxDrift;
+    //Double_t xtop    = x0 + dxAmp;
+               
+               //temporary !! (A.Bercuci)
+    Int_t T0 = (Int_t)fCalibration->GetT0Average(AliTRDgeometry::GetDetector(layer, 2, gs));
+
+    Int_t nTimeBins =  AliTRDcalibDB::Instance()->GetNumberOfTimeBins();    
+    for (Int_t iTime = 0; iTime < nTimeBins; iTime++) {
+
+      Double_t xlayer = iTime * dx - dxAmp;
+      //if (xlayer<0) xlayer = dxAmp / 2.0;
+      x = x0 - xlayer;
+
+      tbIndex = CookTimeBinIndex(layer,iTime);
+      ppl     = new AliTRDpropagationLayer(x,dx,rho,radLength,tbIndex,layer);
+      ppl->SetYmax(ymax,ymaxsensitive);
+      ppl->SetZ(zc,zmax,zmaxsensitive);
+      ppl->SetHoles(holes);
+      if(iTime == T0) ppl->SetT0();
+                       
+                       InsertLayer(ppl);      
+
+    }
+
+  }    
+
+  MapTimeBinLayers();
+
+  delete [] zc;
+  delete [] zmax;
+  delete [] zmaxsensitive;
+
+}
+
+//_____________________________________________________________________________
+AliTRDtracker::AliTRDtrackingSector
+             ::AliTRDtrackingSector(const AliTRDtrackingSector &/*t*/)
+  :fN(0)
+  ,fGeom(0)
+  ,fGeomSector(0)
+{
+  //
+  // Copy constructor
+  //
+
+}
+
+//_____________________________________________________________________________
+AliTRDtracker::AliTRDtrackingSector
+             ::~AliTRDtrackingSector()
+{
+  //
+  // Destructor
+  //
+
+  for (Int_t i = 0; i < fN; i++) {
+    delete fLayers[i]; 
+  }
+
+}
+
+//_____________________________________________________________________________
+Int_t  AliTRDtracker::AliTRDtrackingSector
+                    ::CookTimeBinIndex(Int_t plane, Int_t localTB) const
+{
+  //
+  // Depending on the digitization parameters calculates global
+  // (i.e. for a whole TRD stack of 6 planes) time bin index for 
+  // timebin <localTB> in plane <plane>
+  //
+
+  Int_t tbPerPlane = AliTRDcalibDB::Instance()->GetNumberOfTimeBins();
+  Int_t gtb        = (plane+1) * tbPerPlane - localTB - 1;
+  if (localTB < 0) {
+    return -1;
+  }
+  if (gtb     < 0) {
+    return -1;
+  }
+
+  return gtb;
+
+}
+
+//_____________________________________________________________________________
+void AliTRDtracker::AliTRDtrackingSector
+                  ::MapTimeBinLayers() 
+{
+  //
+  // For all sensitive time bins sets corresponding layer index
+  // in the array fTimeBins 
   //
-  // AliTRDpropagationLayer constructor
+
+  Int_t index;
+
+  for (Int_t i = 0; i < fN; i++) {
+
+    index = fLayers[i]->GetTimeBinIndex();
+    
+    if (index < 0) {
+      continue;
+    }
+    if (index >= (Int_t) kMaxTimeBinIndex) {
+      //AliWarning(Form("Index %d exceeds allowed maximum of %d!\n"
+      //               ,index,kMaxTimeBinIndex-1));
+      continue;
+    }
+
+    fTimeBinIndex[index] = i;
+
+  }
+
+}
+
+//_____________________________________________________________________________
+Int_t AliTRDtracker::AliTRDtrackingSector
+                   ::GetLayerNumber(Double_t x) const
+{
+  // 
+  // Returns the number of time bin which in radial position is closest to <x>
   //
 
-  fN = 0; fX = x; fdX = dx; fRho = rho; fX0 = radLength;
-  fClusters = NULL; fIndex = NULL; fTimeBinIndex = tbIndex;
+  if (x >= fLayers[fN-1]->GetX()) {
+    return fN - 1; 
+  }
+  if (x <= fLayers[   0]->GetX()) {
+    return 0; 
+  }
+
+  Int_t b = 0;
+  Int_t e = fN - 1;
+  Int_t m = (b + e) / 2;
 
+  for ( ; b < e; m = (b + e) / 2) {
+    if (x > fLayers[m]->GetX()) {
+      b = m + 1;
+    }
+    else {
+      e = m;
+    }
+  }
 
-  for(Int_t i=0; i < (Int_t) kZones; i++) {
-    fZc[i]=0; fZmax[i] = 0;
+  if (TMath::Abs(x - fLayers[m]->GetX()) > TMath::Abs(x - fLayers[m+1]->GetX())) {
+    return m + 1;
   }
+  else {
+    return m;
+  }
+
+}
+
+//_____________________________________________________________________________
+Int_t AliTRDtracker::AliTRDtrackingSector
+                   ::GetInnerTimeBin() const 
+{
+  // 
+  // Returns number of the innermost SENSITIVE propagation layer
+  //
+
+  return GetLayerNumber(0);
 
-  fYmax = 0;
+}
+
+//_____________________________________________________________________________
+Int_t AliTRDtracker::AliTRDtrackingSector
+                   ::GetOuterTimeBin() const 
+{
+  // 
+  // Returns number of the outermost SENSITIVE time bin
+  //
+
+  return GetLayerNumber(GetNumberOfTimeBins() - 1);
+
+}
+
+//_____________________________________________________________________________
+Int_t AliTRDtracker::AliTRDtrackingSector
+                   ::GetNumberOfTimeBins() const 
+{
+  // 
+  // Returns number of SENSITIVE time bins
+  //
+
+  Int_t tb;
+  Int_t layer;
 
-  if(fTimeBinIndex >= 0) { 
-    fClusters = new AliTRDcluster*[kMaxClusterPerTimeBin];
-    fIndex = new UInt_t[kMaxClusterPerTimeBin];
+  for (tb = kMaxTimeBinIndex - 1; tb >= 0; tb--) {
+    layer = GetLayerNumber(tb);
+    if (layer >= 0) {
+      break;
+    }
   }
 
-  for (Int_t i=0;i<5;i++) fIsHole[i] = kFALSE;
-  fHole = kFALSE;
-  fHoleZc = 0;
-  fHoleZmax = 0;
-  fHoleYc = 0;
-  fHoleYmax = 0;
-  fHoleRho = 0;
-  fHoleX0 = 0;
+  return tb + 1;
 
 }
 
-//_______________________________________________________
-void AliTRDtracker::AliTRDpropagationLayer::SetHole(
-          Double_t Zmax, Double_t Ymax, Double_t rho, 
-          Double_t radLength, Double_t Yc, Double_t Zc) 
+//_____________________________________________________________________________
+void AliTRDtracker::AliTRDtrackingSector
+                  ::InsertLayer(AliTRDpropagationLayer *pl)
+{ 
+  //
+  // Insert layer <pl> in fLayers array.
+  // Layers are sorted according to X coordinate.
+  //
+
+  if (fN == ((Int_t) kMaxLayersPerSector)) {
+    //AliWarning("Too many layers !\n");
+    return;
+  }
+
+  if (fN == 0) {
+    fLayers[fN++] = pl; 
+    return;
+  }
+
+  Int_t i = Find(pl->GetX());
+
+  memmove(fLayers+i+1,fLayers+i,(fN-i)*sizeof(AliTRDpropagationLayer*));
+
+  fLayers[i] = pl; 
+  fN++;
+
+}              
+
+//_____________________________________________________________________________
+Int_t AliTRDtracker::AliTRDtrackingSector
+                   ::Find(Double_t x) const 
+{
+  //
+  // Returns index of the propagation layer nearest to X 
+  //
+
+  if (x <= fLayers[0]->GetX()) {
+    return 0;
+  }
+
+  if (x > fLayers[fN-1]->GetX()) {
+    return fN;
+  }
+
+  Int_t b = 0;
+  Int_t e = fN-1;
+  Int_t m = (b + e) / 2;
+
+  for (; b < e; m = (b + e) / 2) {
+    if (x > fLayers[m]->GetX()) {
+      b = m + 1;
+    }
+    else {
+      e = m;
+    }
+  }
+
+  return m;
+
+}             
+
+//_____________________________________________________________________________
+Double_t AliTRDtracker::GetTiltFactor(const AliTRDcluster *c) 
 {
   //
-  // Sets hole in the layer 
+  // Returns correction factor for tilted pads geometry 
   //
-  fHole = kTRUE;
-  fHoleZc = Zc;
-  fHoleZmax = Zmax;
-  fHoleYc = Yc;
-  fHoleYmax = Ymax;
-  fHoleRho = rho;
-  fHoleX0 = radLength;
+
+  Int_t    det   = c->GetDetector();    
+  Int_t    layer = fGeom->GetLayer(det);
+  AliTRDpadPlane *padPlane = fGeom->GetPadPlane(layer,0);
+  Double_t h01   = TMath::Tan(-TMath::Pi() / 180.0 * padPlane->GetTiltingAngle());
+
+  if (fNoTilt) {
+    h01 = 0;
+  }
+
+  return h01;
+
 }
-  
 
-//_______________________________________________________
-AliTRDtracker::AliTRDtrackingSector::AliTRDtrackingSector(AliTRDgeometry* geo, Int_t gs, AliTRDparameter* par)
+//_____________________________________________________________________________
+Int_t AliTRDtracker::FindClusters(Int_t sector, Int_t t0, Int_t t1
+                                , AliTRDtrack *track
+                                , Int_t *clusters
+                                , AliTRDtracklet &tracklet)
 {
   //
-  // AliTRDtrackingSector Constructor
-  //
+  // Try to find the nearest clusters to the track in the time bins 
+  // between <t0> and <t1>. 
+  // Also the corresponding tracklet is calculated
+  // Correction coeficients - depend on TRD parameters - to be changed accordingly
+  //
+
+  const Int_t    kN1 = 100;
+  const Int_t    kN2 = 10;
+
+  Double_t       x[kN1];
+  Double_t       yt[kN1];
+  Double_t       zt[kN1];
+  Float_t        zmean[kN1];
+  Float_t        nmean[kN1];
+
+  Double_t       dz[kN2][kN1];
+  Double_t       dy[kN2][kN1];
+  Int_t          indexes[kN2][kN1];  // Indexes of the clusters in the road
+  Int_t          best[kN2][kN1];     // Index of best matching cluster 
+  AliTRDcluster *cl[kN2][kN1];       // Pointers to the clusters in the road
+
+  Double_t xmean   = 0.0;            // Reference x
+  Int_t    clfound = 0;
+
+  // Initialize the arrays
+  for (Int_t it = 0; it < kN1; it++) {
+
+    x[it]        =  0.0;
+    yt[it]       =  0.0;
+    zt[it]       =  0.0;
+    clusters[it] = -2;
+    zmean[it]    =  0.0;
+    nmean[it]    =  0.0;
+
+    for (Int_t ih = 0; ih < kN2; ih++) {
+      indexes[ih][it] = -2;
+      cl[ih][it]      =  0;
+      dz[ih][it]      = -100.0;
+      dy[ih][it]      = -100.0;
+      best[ih][it]    =  0;
+    }
 
-  fGeom = geo;
-  fPar = par;
-  fGeomSector = gs;
-  fTzeroShift = 0.13;
-  fN = 0;
-  //
-  // get holes description from geometry
-  Bool_t holes[AliTRDgeometry::kNcham];
-  //printf("sector\t%d\t",gs);
-  for (Int_t icham=0; icham<AliTRDgeometry::kNcham;icham++){
-    holes[icham] = fGeom->IsHole(0,icham,gs);
-    //printf("%d",holes[icham]);
-  } 
-  //printf("\n");
-  
-  for(UInt_t i=0; i < kMaxTimeBinIndex; i++) fTimeBinIndex[i] = -1;
+  }  
 
+  Double_t x0        = track->GetX();
+  Double_t sigmaz    = TMath::Sqrt(TMath::Abs(track->GetSigmaZ2()));
+  Int_t    nall      = 0;
+  Int_t    nfound    = 0;
+  Double_t h01       = 0.0;
+  Int_t    layer     = -1;
+  Int_t    detector  = -1;
+  Float_t  padlength = 0.0;
 
-  AliTRDpropagationLayer* ppl;
+  AliTRDtrack track2(* track);
+  Float_t  snpy      = track->GetSnp();
+  Float_t  tany      = TMath::Sqrt(snpy*snpy / (1.0 - snpy*snpy)); 
+  if (snpy < 0.0) {
+    tany *= -1.0;
+  }
 
-  Double_t x, xin, xout, dx, rho, radLength;
-  Int_t    steps;
+  Double_t sy2       = ExpectedSigmaY2(x0,track->GetTgl(),track->GetSignedPt());
+  Double_t sz2       = ExpectedSigmaZ2(x0,track->GetTgl());
+  Double_t road      = 15.0 * TMath::Sqrt(track->GetSigmaY2() + sy2);
+  if (road > 6.0) {
+    road = 6.0;
+  }
 
-  // set time bins in the gas of the TPC
+  for (Int_t it = 0; it < t1-t0; it++) {
 
-  xin = 246.055; xout = 254.055; steps = 20; dx = (xout-xin)/steps;
-  rho = 0.9e-3;  radLength = 28.94;
+    Double_t maxChi2[2] = { fgkMaxChi2, fgkMaxChi2 };      
+    AliTRDpropagationLayer &timeBin = *(fTrSec[sector]->GetLayer(it+t0));
+    if (timeBin == 0) {
+      continue; // No indexes1
+    }
 
-  for(Int_t i=0; i<steps; i++) {
-    x = xin + i*dx + dx/2;
-    ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);
-    InsertLayer(ppl);
-  }
+    Int_t    maxn = timeBin;
+    x[it]  = timeBin.GetX();
+    track2.PropagateTo(x[it]);
+    yt[it] = track2.GetY();
+    zt[it] = track2.GetZ();
+    
+    Double_t y    = yt[it];
+    Double_t z    = zt[it];
+    Double_t chi2 = 1000000.0;
+    nall++;
 
-  // set time bins in the outer field cage vessel
+    //
+    // Find 2 nearest cluster at given time bin
+    // 
+    Int_t    checkPoint[4] = { 0, 0, 0, 0 };
+    Double_t minY          = 123456789.0;
+    Double_t minD[2]       = { 1.0, 1.0 };
+
+    for (Int_t i = timeBin.Find(y - road); i < maxn; i++) {
+
+      AliTRDcluster *c = (AliTRDcluster *) (timeBin[i]);
+      h01 = GetTiltFactor(c);
+      if (layer < 0) {
+       Int_t det = c->GetDetector();
+       layer     = fGeom->GetLayer(det);
+       padlength = TMath::Sqrt(c->GetSigmaZ2() * 12.0);
+      }
 
-  dx = 50e-4; xin = xout; xout = xin + dx; rho = 1.71; radLength = 44.77; // Tedlar
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+      if (c->GetY() > (y + road)) {
+        break;
+      }
 
-  dx = 0.02; xin = xout; xout = xin + dx; rho = 1.45; radLength = 44.86; // prepreg
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+      fHDeltaX->Fill(c->GetX() - x[it]);
 
-  dx = 2.; xin = xout; xout = xin + dx; rho = 1.45*0.02; radLength = 41.28; // Nomex
-  steps = 5; dx = (xout - xin)/steps;
-  for(Int_t i=0; i<steps; i++) {
-    x = xin + i*dx + dx/2;
-    ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);
-    InsertLayer(ppl);
-  }
+      if (TMath::Abs(c->GetY()-y) < TMath::Abs(minY)) {
+       minY    = c->GetY() - y;
+       minD[0] = c->GetY() - y;
+       minD[1] = c->GetZ() - z;
+      }
 
-  dx = 0.02; xin = xout; xout = xin + dx; rho = 1.45; radLength = 44.86; // prepreg
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+      checkPoint[0]++;
 
-  dx = 50e-4; xin = xout; xout = xin + dx; rho = 1.71; radLength = 44.77; // Tedlar
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+      fHMinZ->Fill(c->GetZ() - z);
+      if ((c->GetZ() - z) * (c->GetZ() - z) > 2 * (12.0 * sz2)) {
+        continue;
+      }
+      checkPoint[1]++;
 
+      Double_t dist = TMath::Abs(c->GetZ() - z);
+      if (dist > (0.5 * padlength + 6.0 * sigmaz)) {
+        continue;   // 6 sigma boundary cut
+      }
+      checkPoint[2]++;
+
+      // Sigma boundary cost function
+      Double_t cost = 0.0;
+      if (dist> (0.5 * padlength - sigmaz)){ 
+       cost =  (dist - 0.5*padlength) / (2.0 * sigmaz);
+       if (cost > -1) {
+          cost = (cost + 1.0) * (cost + 1.0);
+       }
+       else {
+          cost = 0.0;
+       }
+      }
+      chi2 = track2.GetPredictedChi2(c,h01) + cost;
+      clfound++;      
 
-  // set time bins in CO2
+      if (chi2 > maxChi2[1]) {
+        continue;
+      }
+      checkPoint[3]++;
+
+      // Store the clusters in the road
+      detector = c->GetDetector();
+      for (Int_t ih = 2; ih < 9; ih++) {  
+       if (cl[ih][it] == 0) {
+         cl[ih][it]      = c;
+         indexes[ih][it] = timeBin.GetIndex(i); // Index - 9 - reserved for outliers
+         break;
+       }
+      }
 
-  xin = xout; xout = 275.0; 
-  steps = 50; dx = (xout - xin)/steps;
-  rho = 1.977e-3;  radLength = 36.2;
-  
-  for(Int_t i=0; i<steps; i++) {
-    x = xin + i*dx + dx/2;
-    ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);
-    InsertLayer(ppl);
-  }
+      if (chi2 < maxChi2[0]) {
+       maxChi2[1]     = maxChi2[0];
+       maxChi2[0]     = chi2;
+       indexes[1][it] = indexes[0][it];
+       cl[1][it]      = cl[0][it];
+       indexes[0][it] = timeBin.GetIndex(i);
+       cl[0][it]      = c;
+       continue;
+      }
+      maxChi2[1]     = chi2;
+      cl[1][it]      = c;
+      indexes[1][it] = timeBin.GetIndex(i); 
 
-  // set time bins in the outer containment vessel
+    }
+    
+    for(int iCheckPoint = 0; iCheckPoint<4; iCheckPoint++) {
+      fHFindCl[iCheckPoint]->Fill(checkPoint[iCheckPoint]);
+    }
 
-  dx = 50e-4; xin = xout; xout = xin + dx; rho = 2.7; radLength = 24.01; // Al
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+    if (checkPoint[3]) {
+      if (track->GetSignedPt() > 0) {
+        fHMinYPos->Fill(minY);
+      }
+      else {
+        fHMinYNeg->Fill(minY);
+      }
+      fHMinD->Fill(minD[0],minD[1]);
+    }
 
-  dx = 50e-4; xin = xout; xout = xin + dx; rho = 1.71; radLength = 44.77; // Tedlar
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+    if (cl[0][it]) {
+      nfound++;
+      xmean += x[it];
+    }
 
-  dx = 0.06; xin = xout; xout = xin + dx; rho = 1.45; radLength = 44.86; // prepreg
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+  }
 
-  dx = 3.; xin = xout; xout = xin + dx; rho = 1.45*0.02; radLength = 41.28; // Nomex
-  steps = 10; dx = (xout - xin)/steps;
-  for(Int_t i=0; i<steps; i++) {
-    x = xin + i*dx + dx/2;
-    ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);
-    InsertLayer(ppl);
+  if (nfound < 4) {
+    return 0;  
   }
+  xmean /= Float_t(nfound);  // Middle x
+  track2.PropagateTo(xmean); // Propagate track to the center
+
+  //
+  // Choose one of the variants
+  //
+  Float_t  sumz   = 0.0;
+  Float_t  sum    = 0.0;
+  Double_t sumdy  = 0.0;
+  Double_t sumdy2 = 0.0;
+  Double_t sumx   = 0.0;
+  Double_t sumxy  = 0.0;
+  Double_t sumx2  = 0.0;
+  Double_t mpads  = 0.0;
 
-  dx = 0.06; xin = xout; xout = xin + dx; rho = 1.45; radLength = 44.86; // prepreg
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+  Int_t    changes[kN2];
 
-  dx = 50e-4; xin = xout; xout = xin + dx; rho = 1.71; radLength = 44.77; // Tedlar
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
-  
-  dx = 50e-4; xin = xout; xout = xin + dx; rho = 2.7; radLength = 24.01; // Al
-  ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-  InsertLayer(ppl);
+  Int_t    ngood[kN2];
+  Int_t    nbad[kN2];
 
-  Double_t xtrd = (Double_t) fGeom->Rmin();  
+  Double_t meanz[kN2];
+  Double_t moffset[kN2];    // Mean offset
+  Double_t mean[kN2];       // Mean value
+  Double_t angle[kN2];      // Angle
 
-  // add layers between TPC and TRD (Air temporarily)
-  xin = xout; xout = xtrd;
-  steps = 50; dx = (xout - xin)/steps;
-  rho = 1.2e-3;  radLength = 36.66;
-  
-  for(Int_t i=0; i<steps; i++) {
-    x = xin + i*dx + dx/2;
-    ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);
-    InsertLayer(ppl);
-  }
+  Double_t smoffset[kN2];   // Sigma of mean offset
+  Double_t smean[kN2];      // Sigma of mean value
+  Double_t sangle[kN2];     // Sigma of angle
+  Double_t smeanangle[kN2]; // Correlation
 
+  Double_t sigmas[kN2];     
+  Double_t tchi2s[kN2];     // Chi2s for tracklet
 
-  //  Double_t alpha=AliTRDgeometry::GetAlpha();
+  for (Int_t it = 0; it < kN2; it++) {
 
-  // add layers for each of the planes
+    ngood[it]      = 0;
+    nbad[it]       = 0;
 
-  Double_t dxRo = (Double_t) fGeom->CroHght();    // Rohacell 
-  Double_t dxSpace = (Double_t) fGeom->Cspace();  // Spacing between planes
-  Double_t dxAmp = (Double_t) fGeom->CamHght();   // Amplification region
-  Double_t dxDrift = (Double_t) fGeom->CdrHght(); // Drift region  
-  Double_t dxRad = (Double_t) fGeom->CraHght();   // Radiator
-  Double_t dxTEC = dxRad + dxDrift + dxAmp + dxRo; 
-  Double_t dxPlane = dxTEC + dxSpace; 
+    meanz[it]      = 0.0;
+    moffset[it]    = 0.0;   // Mean offset
+    mean[it]       = 0.0;   // Mean value
+    angle[it]      = 0.0;   // Angle
 
-  Int_t tb, tbIndex;
-  const Int_t  kNchambers = AliTRDgeometry::Ncham();
-  Double_t  ymax = 0;
-  //, holeYmax = 0;
-  Double_t ymaxsensitive=0;
-  Double_t *zc = new Double_t[kNchambers];
-  Double_t *zmax = new Double_t[kNchambers];
-  Double_t *zmaxsensitive = new Double_t[kNchambers];  
-  //  Double_t  holeZmax = 1000.;   // the whole sector is missing
+    smoffset[it]   = 1.0e5; // Sigma of mean offset
+    smean[it]      = 1.0e5; // Sigma of mean value
+    sangle[it]     = 1.0e5; // Sigma of angle
+    smeanangle[it] = 0.0;   // Correlation
 
-  for(Int_t plane = 0; plane < AliTRDgeometry::Nplan(); plane++) {
-    //
-    // Radiator 
-    xin = xtrd + plane * dxPlane; xout = xin + dxRad;
-    steps = 12; dx = (xout - xin)/steps; rho = 0.074; radLength = 40.6; 
-    for(Int_t i=0; i<steps; i++) {
-      x = xin + i*dx + dx/2;
-      ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);      
-      InsertLayer(ppl);
-    }
+    sigmas[it]     = 1.0e5;     
+    tchi2s[it]     = 1.0e5; // Chi2s for tracklet
 
-    ymax          = fGeom->GetChamberWidth(plane)/2.;
-    ymaxsensitive = (fPar->GetColPadSize(plane)*fPar->GetColMax(plane)-4)/2.;
-    
-    for(Int_t ch = 0; ch < kNchambers; ch++) {
-      zmax[ch] = fGeom->GetChamberLength(plane,ch)/2;
-      Float_t pad = fPar->GetRowPadSize(plane,ch,0);
-      Float_t row0 = fPar->GetRow0(plane,ch,0);
-      Int_t nPads = fPar->GetRowMax(plane,ch,0);
-      zmaxsensitive[ch] = Float_t(nPads)*pad/2.;      
-      //      zc[ch] = (pad * nPads)/2 + row0 - pad/2;
-      zc[ch] = (pad * nPads)/2 + row0;
-      //zc[ch] = row0+zmax[ch]-AliTRDgeometry::RpadW();
+  }
 
+  //
+  // Calculate zmean
+  //
+  for (Int_t it = 0; it < t1 - t0; it++) {
+    if (!cl[0][it]) {
+      continue;
+    }
+    for (Int_t dt = -3; dt <= 3; dt++) {
+      if (it+dt <     0) {
+        continue;
+      }
+      if (it+dt > t1-t0) {
+        continue;
+      }
+      if (!cl[0][it+dt]) {
+        continue;
+      }
+      zmean[it] += cl[0][it+dt]->GetZ();
+      nmean[it] += 1.0;
     }
+    zmean[it] /= nmean[it]; 
+  }
 
-    dx = fPar->GetTimeBinSize(); 
-    rho = 0.00295 * 0.85; radLength = 11.0;  
+  for (Int_t it = 0; it < t1 - t0; it++) {
 
-    Double_t x0 = (Double_t) fPar->GetTime0(plane);
-    Double_t xbottom = x0 - dxDrift;
-    Double_t xtop = x0 + dxAmp;
-    //
-    // Amplification region
-    steps = (Int_t) (dxAmp/dx);
+    best[0][it] = 0;
 
-    for(tb = 0; tb < steps; tb++) {
-      x = x0 + tb * dx + dx/2;
-      tbIndex = CookTimeBinIndex(plane, -tb-1);
-      ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,tbIndex);
-      ppl->SetYmax(ymax,ymaxsensitive);
-      ppl->SetZ(zc, zmax, zmaxsensitive);
-      ppl->SetHoles(holes);
-      InsertLayer(ppl);
-    }
-    tbIndex = CookTimeBinIndex(plane, -steps);
-    x = (x + dx/2 + xtop)/2;
-    dx = 2*(xtop-x);
-    ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,tbIndex);
-    ppl->SetYmax(ymax,ymaxsensitive);
-    ppl->SetZ(zc, zmax,zmaxsensitive);
-    ppl->SetHoles(holes);
-    InsertLayer(ppl);
-
-    // Drift region
-    dx = fPar->GetTimeBinSize();
-    steps = (Int_t) (dxDrift/dx);
-
-    for(tb = 0; tb < steps; tb++) {
-      x = x0 - tb * dx - dx/2;
-      tbIndex = CookTimeBinIndex(plane, tb);
-
-      ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,tbIndex);
-      ppl->SetYmax(ymax,ymaxsensitive);
-      ppl->SetZ(zc, zmax, zmaxsensitive);
-      ppl->SetHoles(holes);
-      InsertLayer(ppl);
-    }
-    tbIndex = CookTimeBinIndex(plane, steps);
-    x = (x - dx/2 + xbottom)/2;
-    dx = 2*(x-xbottom);
-    ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,tbIndex);
-    ppl->SetYmax(ymax,ymaxsensitive);
-    ppl->SetZ(zc, zmax, zmaxsensitive);
-    ppl->SetHoles(holes);    
-    InsertLayer(ppl);
-
-    // Pad Plane
-    xin = xtop; dx = 0.025; xout = xin + dx; rho = 1.7; radLength = 33.0;
-    ppl = new AliTRDpropagationLayer(xin+dx/2,dx,rho,radLength,-1);
-    ppl->SetYmax(ymax,ymaxsensitive);
-    ppl->SetZ(zc, zmax,zmax);
-    ppl->SetHoles(holes);        
-    InsertLayer(ppl);
-
-    // Rohacell
-    xin = xout; xout = xtrd + (plane + 1) * dxPlane - dxSpace;
-    steps = 5; dx = (xout - xin)/steps; rho = 0.074; radLength = 40.6; 
-    for(Int_t i=0; i<steps; i++) {
-      x = xin + i*dx + dx/2;
-      ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);
-      ppl->SetYmax(ymax,ymaxsensitive);
-      ppl->SetZ(zc, zmax,zmax);
-      ppl->SetHoles(holes);
-      InsertLayer(ppl);
+    for (Int_t ih = 0; ih < 10; ih++) {
+      dz[ih][it] = -100.0;
+      dy[ih][it] = -100.0;
+      if (!cl[ih][it]) {
+        continue;
+      }
+      Double_t xcluster = cl[ih][it]->GetX();
+      Double_t ytrack;
+      Double_t ztrack;
+      track2.GetProlongation(xcluster,ytrack,ztrack );
+      dz[ih][it] = cl[ih][it]->GetZ()- ztrack;                   // Calculate distance from track in z
+      dy[ih][it] = cl[ih][it]->GetY() + dz[ih][it]*h01 - ytrack; // and in y
     }
 
-    // Space between the chambers, air
-    xin = xout; xout = xtrd + (plane + 1) * dxPlane;
-    steps = 5; dx = (xout - xin)/steps; rho = 1.29e-3; radLength = 36.66; 
-    for(Int_t i=0; i<steps; i++) {
-      x = xin + i*dx + dx/2;
-      ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);
-      InsertLayer(ppl);
+    // Minimize changes
+    if (!cl[0][it]) {
+      continue;
+    }
+    if ((TMath::Abs(cl[0][it]->GetZ()-zmean[it]) > padlength * 0.8) &&
+        (cl[1][it])) {
+      if (TMath::Abs(cl[1][it]->GetZ()-zmean[it]) < padlength * 0.5) {
+       best[0][it] = 1;
+      }
     }
-  }    
 
-  // Space between the TRD and RICH
-  Double_t xRICH = 500.;
-  xin = xout; xout = xRICH;
-  steps = 200; dx = (xout - xin)/steps; rho = 1.29e-3; radLength = 36.66; 
-  for(Int_t i=0; i<steps; i++) {
-    x = xin + i*dx + dx/2;
-    ppl = new AliTRDpropagationLayer(x,dx,rho,radLength,-1);
-    InsertLayer(ppl);
   }
 
-  MapTimeBinLayers();
-  delete [] zc;
-  delete [] zmax;
-
-}
-
-//______________________________________________________
-
-Int_t  AliTRDtracker::AliTRDtrackingSector::CookTimeBinIndex(Int_t plane, Int_t localTB) const
-{
   //
-  // depending on the digitization parameters calculates "global"
-  // time bin index for timebin <localTB> in plane <plane>
+  // Iterative choice of "best path"
   //
+  Int_t label    = TMath::Abs(track->GetLabel());
+  Int_t bestiter = 0;
 
-  Double_t dxAmp = (Double_t) fGeom->CamHght();   // Amplification region
-  Double_t dxDrift = (Double_t) fGeom->CdrHght(); // Drift region  
-  Double_t dx = (Double_t) fPar->GetTimeBinSize();  
-
-  Int_t tbAmp = fPar->GetTimeBefore();
-  Int_t maxAmp = (Int_t) ((dxAmp+0.000001)/dx);
-  if(kTRUE) maxAmp = 0;   // intentional until we change parameter class 
-  Int_t tbDrift = fPar->GetTimeMax();
-  Int_t maxDrift = (Int_t) ((dxDrift+0.000001)/dx);
+  for (Int_t iter = 0; iter < 9; iter++) {
 
-  Int_t tbPerPlane = TMath::Min(tbAmp,maxAmp) + TMath::Min(tbDrift,maxDrift);
+    changes[iter] = 0;
+    sumz          = 0; 
+    sum           = 0; 
+    sumdy         = 0;
+    sumdy2        = 0;
+    sumx          = 0;
+    sumx2         = 0;
+    sumxy         = 0;
+    mpads         = 0; 
+    ngood[iter]   = 0; 
+    nbad[iter]    = 0;
+    // Linear fit
+    for (Int_t it = 0; it < t1 - t0; it++) {
 
-  Int_t gtb = (plane+1) * tbPerPlane - localTB - 1 - TMath::Min(tbAmp,maxAmp);
+      if (!cl[best[iter][it]][it]) {
+        continue;
+      }
 
-  if((localTB < 0) && 
-     (TMath::Abs(localTB) > TMath::Min(tbAmp,maxAmp))) return -1;
-  if(localTB >= TMath::Min(tbDrift,maxDrift)) return -1;
+      // Calculates pad-row changes
+      Double_t zbefore = cl[best[iter][it]][it]->GetZ();
+      Double_t zafter  = cl[best[iter][it]][it]->GetZ();
+      for (Int_t itd = it - 1; itd >= 0; itd--) {
+       if (cl[best[iter][itd]][itd]) {
+         zbefore = cl[best[iter][itd]][itd]->GetZ();
+         break;
+       }
+      }
+      for (Int_t itd = it + 1; itd < t1 - t0; itd++) {
+       if (cl[best[iter][itd]][itd]) {
+         zafter  = cl[best[iter][itd]][itd]->GetZ();
+         break;
+       }
+      }
+      if ((TMath::Abs(cl[best[iter][it]][it]->GetZ()-zbefore) > 0.1) &&
+          (TMath::Abs(cl[best[iter][it]][it]->GetZ()- zafter) > 0.1)) {
+        changes[iter]++;
+      }
 
-  return gtb;
+      // Distance to reference x
+      Double_t dx = x[it]-xmean; 
+      sumz   += cl[best[iter][it]][it]->GetZ();      
+      sum++;
+      sumdy  += dy[best[iter][it]][it];
+      sumdy2 += dy[best[iter][it]][it]*dy[best[iter][it]][it];
+      sumx   += dx;
+      sumx2  += dx*dx;
+      sumxy  += dx*dy[best[iter][it]][it];
+      mpads  += cl[best[iter][it]][it]->GetNPads();
+      if ((cl[best[iter][it]][it]->GetLabel(0) == label) || 
+          (cl[best[iter][it]][it]->GetLabel(1) == label) || 
+          (cl[best[iter][it]][it]->GetLabel(2) == label)) {
+       ngood[iter]++;
+      }
+      else {
+       nbad[iter]++;
+      }
 
+    }
 
-}
+    //
+    // Calculates line parameters
+    //
+    Double_t det  = sum*sumx2 - sumx*sumx;
+    angle[iter]   = (sum*sumxy - sumx*sumdy) / det;
+    mean[iter]    = (sumx2*sumdy - sumx*sumxy) / det;
+    meanz[iter]   = sumz  / sum;    
+    moffset[iter] = sumdy / sum;
+    mpads        /= sum;   // Mean number of pads
+
+    Double_t sigma2 = 0.0; // Normalized residuals - for line fit
+    Double_t sigma1 = 0.0; // Normalized residuals - constant fit
+
+    for (Int_t it = 0; it < t1 - t0; it++) {
+      if (!cl[best[iter][it]][it]) {
+        continue;
+      }
+      Double_t dx  = x[it] - xmean;
+      Double_t ytr = mean[iter] + angle[iter] * dx;
+      sigma2 += (dy[best[iter][it]][it] - ytr) 
+              * (dy[best[iter][it]][it] - ytr);
+      sigma1 += (dy[best[iter][it]][it] - moffset[iter]) 
+              * (dy[best[iter][it]][it] - moffset[iter]);
+      sum++;
+    }
+    sigma2          /= (sum - 2);                  // Normalized residuals
+    sigma1          /= (sum - 1);                  // Normalized residuals
+    smean[iter]      = sigma2 * (sumx2 / det);     // Estimated error2 of mean
+    sangle[iter]     = sigma2 * ( sum  / det);     // Estimated error2 of angle
+    smeanangle[iter] = sigma2 * (-sumx / det);     // Correlation
+    sigmas[iter]     = TMath::Sqrt(sigma1);
+    smoffset[iter]   = (sigma1 / sum) + 0.01*0.01; // Sigma of mean offset + unisochronity sigma 
 
-//______________________________________________________
+    //
+    // Iterative choice of "better path"
+    //
+    for (Int_t it = 0; it < t1 - t0; it++) {
 
-void AliTRDtracker::AliTRDtrackingSector::MapTimeBinLayers() 
-{
-  //
-  // For all sensitive time bins sets corresponding layer index
-  // in the array fTimeBins 
-  //
+      if (!cl[best[iter][it]][it]) {
+        continue;
+      }
 
-  Int_t index;
+      // Add unisochronity + angular effect contribution
+      Double_t sigmatr2 = smoffset[iter] + 0.5*tany*tany;                   
+      Double_t sweight  = 1.0/sigmatr2 + 1.0/track->GetSigmaY2();
+      Double_t weighty  = (moffset[iter] / sigmatr2) / sweight;             // Weighted mean
+      Double_t sigmacl  = TMath::Sqrt(sigma1*sigma1 + track->GetSigmaY2());
+      Double_t mindist  = 100000.0; 
+      Int_t    ihbest   = 0;
+
+      for (Int_t ih = 0; ih < kN2; ih++) {
+       if (!cl[ih][it]) {
+          break;
+       }
+       Double_t dist2 = (dy[ih][it] - weighty) / sigmacl;
+       dist2 *= dist2; // Chi2 distance
+       if (dist2 < mindist) {
+         mindist = dist2;
+         ihbest  = ih;
+       }
+      }
 
-  for(Int_t i = 0; i < fN; i++) {
-    index = fLayers[i]->GetTimeBinIndex();
-    
-    //    printf("gtb %d -> pl %d -> x %f \n", index, i, fLayers[i]->GetX());
+      best[iter+1][it] = ihbest;
 
-    if(index < 0) continue;
-    if(index >= (Int_t) kMaxTimeBinIndex) {
-      printf("*** AliTRDtracker::MapTimeBinLayers: \n");
-      printf("    index %d exceeds allowed maximum of %d!\n",
-             index, kMaxTimeBinIndex-1);
-      continue;
     }
-    fTimeBinIndex[index] = i;
-  }
 
-  Double_t x1, dx1, x2, dx2, gap;
+    //
+    // Update best hypothesy if better chi2 according tracklet position and angle
+    //
+             sy2 = smean[iter]  + track->GetSigmaY2();
+    Double_t sa2 = sangle[iter] + track->GetSigmaSnp2(); // track->fCee;
+    Double_t say = track->GetSigmaSnpY();                // track->fCey;
 
-  for(Int_t i = 0; i < fN-1; i++) {
-    x1 = fLayers[i]->GetX();
-    dx1 = fLayers[i]->GetdX();
-    x2 = fLayers[i+1]->GetX();
-    dx2 = fLayers[i+1]->GetdX();
-    gap = (x2 - dx2/2) - (x1 + dx1/2);
-    if(gap < -0.01) {
-      printf("*** warning: layers %d and %d are overlayed:\n",i,i+1);
-      printf("             %f + %f + %f > %f\n", x1, dx1/2, dx2/2, x2);
-    }
-    if(gap > 0.01) { 
-      printf("*** warning: layers %d and %d have a large gap:\n",i,i+1);
-      printf("             (%f - %f) - (%f + %f) = %f\n", 
-             x2, dx2/2, x1, dx1, gap);
+    Double_t detchi    = sy2*sa2 - say*say;
+    Double_t invers[3] = {sa2/detchi,sy2/detchi,-say/detchi}; // Inverse value of covariance matrix  
+    
+    Double_t chi20 = mean[bestiter]  * mean[bestiter]       * invers[0]
+                   + angle[bestiter] * angle[bestiter]      * invers[1]
+                   + 2.0 * mean[bestiter] * angle[bestiter] * invers[2];
+    Double_t chi21 = mean[iter]  * mean[iter]               * invers[0]
+                   + angle[iter] * angle[iter]              * invers[1]
+                   + 2.0 * mean[iter] * angle[iter]         * invers[2];
+    tchi2s[iter]   = chi21;
+
+    if ((changes[iter] <= changes[bestiter]) && 
+        (chi21 < chi20)) {
+      bestiter = iter;
     }
-  }
-}
-  
-
-//______________________________________________________
 
+  }
 
-Int_t AliTRDtracker::AliTRDtrackingSector::GetLayerNumber(Double_t x) const
-{
-  // 
-  // Returns the number of time bin which in radial position is closest to <x>
   //
+  // Set clusters 
+  //
+  Double_t sigma2     = sigmas[0]; // Choose as sigma from 0 iteration
+  Short_t  maxpos     = -1;
+  Float_t  maxcharge  =  0.0;
+  Short_t  maxpos4    = -1;
+  Float_t  maxcharge4 =  0.0;
+  Short_t  maxpos5    = -1;
+  Float_t  maxcharge5 =  0.0;
 
-  if(x >= fLayers[fN-1]->GetX()) return fN-1; 
-  if(x <= fLayers[0]->GetX()) return 0; 
-
-  Int_t b=0, e=fN-1, m=(b+e)/2;
-  for (; b<e; m=(b+e)/2) {
-    if (x > fLayers[m]->GetX()) b=m+1;
-    else e=m;
+  Double_t exB         = AliTRDcalibDB::Instance()->GetOmegaTau(AliTRDcalibDB::Instance()->GetVdrift(0,0,0)
+                                                               ,-AliTracker::GetBz()*0.1);
+  Double_t expectederr = sigma2*sigma2 + 0.01*0.01;
+  if (mpads > 3.5) {
+    expectederr += (mpads - 3.5) * 0.04;
+  }
+  if (changes[bestiter] > 1) {
+    expectederr += changes[bestiter] * 0.01; 
   }
-  if(TMath::Abs(x - fLayers[m]->GetX()) > 
-     TMath::Abs(x - fLayers[m+1]->GetX())) return m+1;
-  else return m;
+  expectederr += (0.03 * (tany-exB)*(tany-exB)) * 15.0;
 
-}
+  for (Int_t it = 0; it < t1 - t0; it++) {
 
-//______________________________________________________
+    if (!cl[best[bestiter][it]][it]) {
+      continue;
+    }
 
-Int_t AliTRDtracker::AliTRDtrackingSector::GetInnerTimeBin() const 
-{
-  // 
-  // Returns number of the innermost SENSITIVE propagation layer
-  //
+    // Set cluster error
+    cl[best[bestiter][it]][it]->SetSigmaY2(expectederr); 
+    if (!cl[best[bestiter][it]][it]->IsUsed()) {
+      cl[best[bestiter][it]][it]->SetY(cl[best[bestiter][it]][it]->GetY()); 
+    }
 
-  return GetLayerNumber(0);
-}
+    // Time bins with maximal charge
+    if (TMath::Abs(cl[best[bestiter][it]][it]->GetQ()) > maxcharge) {
+      maxcharge = TMath::Abs(cl[best[bestiter][it]][it]->GetQ());
+      maxpos    = cl[best[bestiter][it]][it]->GetLocalTimeBin();
+    }
+    
+    if (TMath::Abs(cl[best[bestiter][it]][it]->GetQ()) > maxcharge4) {
+      if (cl[best[bestiter][it]][it]->GetLocalTimeBin() >= 4) {
+       maxcharge4 = TMath::Abs(cl[best[bestiter][it]][it]->GetQ());
+       maxpos4    = cl[best[bestiter][it]][it]->GetLocalTimeBin();
+      }
+    }
 
-//______________________________________________________
+    if (TMath::Abs(cl[best[bestiter][it]][it]->GetQ()) > maxcharge5) {
+      if (cl[best[bestiter][it]][it]->GetLocalTimeBin() >= 5) {
+       maxcharge5 = TMath::Abs(cl[best[bestiter][it]][it]->GetQ());
+       maxpos5    = cl[best[bestiter][it]][it]->GetLocalTimeBin();
+      }
+    }
 
-Int_t AliTRDtracker::AliTRDtrackingSector::GetOuterTimeBin() const 
-{
-  // 
-  // Returns number of the outermost SENSITIVE time bin
-  //
+    // Time bins with maximal charge
+    if (TMath::Abs(cl[best[bestiter][it]][it]->GetQ()) > maxcharge) {
+      maxcharge = TMath::Abs(cl[best[bestiter][it]][it]->GetQ());
+      maxpos    = cl[best[bestiter][it]][it]->GetLocalTimeBin();
+    }
+    
+    if (TMath::Abs(cl[best[bestiter][it]][it]->GetQ()) > maxcharge4) {
+      if (cl[best[bestiter][it]][it]->GetLocalTimeBin() >= 4) {
+       maxcharge4 = TMath::Abs(cl[best[bestiter][it]][it]->GetQ());
+       maxpos4    = cl[best[bestiter][it]][it]->GetLocalTimeBin();
+      }
+    }
 
-  return GetLayerNumber(GetNumberOfTimeBins() - 1);
-}
+    if (TMath::Abs(cl[best[bestiter][it]][it]->GetQ()) > maxcharge5) {
+      if (cl[best[bestiter][it]][it]->GetLocalTimeBin() >= 5) {
+       maxcharge5 = TMath::Abs(cl[best[bestiter][it]][it]->GetQ());
+       maxpos5    = cl[best[bestiter][it]][it]->GetLocalTimeBin();
+      }
+    }
 
-//______________________________________________________
+    clusters[it+t0] = indexes[best[bestiter][it]][it];    
 
-Int_t AliTRDtracker::AliTRDtrackingSector::GetNumberOfTimeBins() const 
-{
-  // 
-  // Returns number of SENSITIVE time bins
-  //
+  } 
 
-  Int_t tb, layer;
-  for(tb = kMaxTimeBinIndex-1; tb >=0; tb--) {
-    layer = GetLayerNumber(tb);
-    if(layer>=0) break;
+  // Set tracklet parameters
+  Double_t trackleterr2 = smoffset[bestiter] + 0.01*0.01;
+  if (mpads > 3.5) {
+    trackleterr2 += (mpads - 3.5) * 0.04;
+  }
+  trackleterr2 += changes[bestiter] * 0.01;
+  trackleterr2 *= TMath::Max(14.0 - nfound,1.0);
+  trackleterr2 += 0.2 * (tany-exB)*(tany-exB); 
+
+  tracklet.Set(xmean
+              ,track2.GetY() + moffset[bestiter]
+              ,meanz[bestiter]
+              ,track2.GetAlpha()
+              ,trackleterr2);
+  tracklet.SetTilt(h01);
+  tracklet.SetP0(mean[bestiter]);
+  tracklet.SetP1(angle[bestiter]);
+  tracklet.SetN(nfound);
+  tracklet.SetNCross(changes[bestiter]);
+  tracklet.SetPlane(layer);
+  tracklet.SetSigma2(expectederr);
+  tracklet.SetChi2(tchi2s[bestiter]);
+  tracklet.SetMaxPos(maxpos,maxpos4,maxpos5);
+  track->SetTracklets(layer,tracklet);
+  track->SetNWrong(track->GetNWrong() + nbad[0]);
+
+  //
+  // Debuging part
+  //
+  TClonesArray array0("AliTRDcluster");
+  TClonesArray array1("AliTRDcluster");
+  array0.ExpandCreateFast(t1 - t0 + 1);
+  array1.ExpandCreateFast(t1 - t0 + 1);
+  TTreeSRedirector &cstream = *fDebugStreamer;
+  AliTRDcluster dummy;
+  Double_t dy0[100];
+  Double_t dyb[100]; 
+
+  for (Int_t it = 0; it < t1 - t0; it++) {
+    dy0[it] = dy[0][it];
+    dyb[it] = dy[best[bestiter][it]][it];
+    if (cl[0][it]) {
+      new(array0[it]) AliTRDcluster(*cl[0][it]);
+    }
+    else {
+      new(array0[it]) AliTRDcluster(dummy);
+    }
+    if(cl[best[bestiter][it]][it]) {
+      new(array1[it]) AliTRDcluster(*cl[best[bestiter][it]][it]);
+    }
+    else{
+      new(array1[it]) AliTRDcluster(dummy);
+    }
   }
-  return tb+1;
-}
 
-//______________________________________________________
+  TGraph graph0(t1-t0,x,dy0);
+  TGraph graph1(t1-t0,x,dyb);
+  TGraph graphy(t1-t0,x,yt);
+  TGraph graphz(t1-t0,x,zt);
+
+  if (fReconstructor->GetStreamLevel(AliTRDReconstructor::kTracker) > 0) {
+    cstream << "tracklet"
+           << "track.="      << track              // Track parameters
+           << "tany="        << tany               // Tangent of the local track angle 
+           << "xmean="       << xmean              // Xmean - reference x of tracklet  
+           << "tilt="        << h01                // Tilt angle
+           << "nall="        << nall               // Number of foundable clusters 
+           << "nfound="      << nfound             // Number of found clusters
+           << "clfound="     << clfound            // Total number of found clusters in road 
+           << "mpads="       << mpads              // Mean number of pads per cluster
+           << "layer="       << layer              // Layer number 
+           << "detector="    << detector           // Detector number
+           << "road="        << road               // The width of the used road
+           << "graph0.="     << &graph0            // x - y = dy for closest cluster
+           << "graph1.="     << &graph1            // x - y = dy for second closest cluster    
+           << "graphy.="     << &graphy            // y position of the track
+           << "graphz.="     << &graphz            // z position of the track
+            //<< "fCl.="        << &array0            // closest cluster
+            //<< "fCl2.="       << &array1            // second closest cluster
+           << "maxpos="      << maxpos             // Maximal charge postion
+           << "maxcharge="   << maxcharge          // Maximal charge 
+           << "maxpos4="     << maxpos4            // Maximal charge postion - after bin 4
+           << "maxcharge4="  << maxcharge4         // Maximal charge         - after bin 4
+           << "maxpos5="     << maxpos5            // Maximal charge postion - after bin 5
+           << "maxcharge5="  << maxcharge5         // Maximal charge         - after bin 5
+           << "bestiter="    << bestiter           // Best iteration number 
+           << "tracklet.="   << &tracklet          // Corrspond to the best iteration
+           << "tchi20="      << tchi2s[0]          // Chi2 of cluster in the 0 iteration
+           << "tchi2b="      << tchi2s[bestiter]   // Chi2 of cluster in the best  iteration
+           << "sigmas0="     << sigmas[0]          // Residuals sigma 
+           << "sigmasb="     << sigmas[bestiter]   // Residulas sigma
+           << "ngood0="      << ngood[0]           // Number of good clusters in 0 iteration
+           << "nbad0="       << nbad[0]            // Number of bad clusters in 0 iteration
+           << "ngoodb="      << ngood[bestiter]    //                        in best iteration    
+           << "nbadb="       << nbad[bestiter]     //                        in best iteration
+           << "changes0="    << changes[0]         // Changes of pardrows in iteration number 0 
+           << "changesb="    << changes[bestiter]  // Changes of pardrows in best iteration
+           << "moffset0="    << moffset[0]         // Offset fixing angle in iter=0
+           << "smoffset0="   << smoffset[0]        // Sigma of offset fixing angle in iter=0
+           << "moffsetb="    << moffset[bestiter]  // Offset fixing angle in iter=best
+           << "smoffsetb="   << smoffset[bestiter] // Sigma of offset fixing angle in iter=best
+           << "mean0="       << mean[0]            // Mean dy in iter=0;
+           << "smean0="      << smean[0]           // Sigma of mean dy in iter=0
+           << "meanb="       << mean[bestiter]     // Mean dy in iter=best
+           << "smeanb="      << smean[bestiter]    // Sigma of mean dy in iter=best
+           << "angle0="      << angle[0]           // Angle deviation in the iteration number 0 
+           << "sangle0="     << sangle[0]          // Sigma of angular deviation in iteration number 0
+           << "angleb="      << angle[bestiter]    // Angle deviation in the best iteration   
+           << "sangleb="     << sangle[bestiter]   // Sigma of angle deviation in the best iteration   
+           << "expectederr=" << expectederr        // Expected error of cluster position
+           << "\n";
+  }
+
+  return nfound;
 
-void AliTRDtracker::AliTRDtrackingSector::InsertLayer(AliTRDpropagationLayer* pl)
-{ 
+}
+
+//_____________________________________________________________________________
+Int_t AliTRDtracker::Freq(Int_t n, const Int_t *inlist
+                        , Int_t *outlist, Bool_t down)
+{    
+  //
+  // Sort eleements according occurancy 
+  // The size of output array has is 2*n 
   //
-  // Insert layer <pl> in fLayers array.
-  // Layers are sorted according to X coordinate.
 
-  if ( fN == ((Int_t) kMaxLayersPerSector)) {
-    printf("AliTRDtrackingSector::InsertLayer(): Too many layers !\n");
-    return;
+  if (n <= 0) {
+    return 0;
   }
-  if (fN==0) {fLayers[fN++] = pl; return;}
-  Int_t i=Find(pl->GetX());
-
-  memmove(fLayers+i+1 ,fLayers+i,(fN-i)*sizeof(AliTRDpropagationLayer*));
-  fLayers[i]=pl; fN++;
 
-}              
+  Int_t *sindexS = new Int_t[n];   // Temporary array for sorting
+  Int_t *sindexF = new Int_t[2*n];   
+  for (Int_t i = 0; i < n; i++) {
+    sindexF[i] = 0;
+  }
 
-//______________________________________________________
+  TMath::Sort(n,inlist,sindexS,down); 
+  Int_t last     = inlist[sindexS[0]];
+  Int_t val      = last;
+  sindexF[0]     = 1;
+  sindexF[0+n]   = last;
+  Int_t countPos = 0;
+
+  // Find frequency
+  for (Int_t i = 1; i < n; i++) {
+    val = inlist[sindexS[i]];
+    if (last == val) {
+      sindexF[countPos]++;
+    }
+    else {      
+      countPos++;
+      sindexF[countPos+n] = val;
+      sindexF[countPos]++;
+      last                = val;
+    }
+  }
+  if (last == val) {
+    countPos++;
+  }
 
-Int_t AliTRDtracker::AliTRDtrackingSector::Find(Double_t x) const 
-{
-  //
-  // Returns index of the propagation layer nearest to X 
-  //
+  // Sort according frequency
+  TMath::Sort(countPos,sindexF,sindexS,kTRUE);
 
-  if (x <= fLayers[0]->GetX()) return 0;
-  if (x > fLayers[fN-1]->GetX()) return fN;
-  Int_t b=0, e=fN-1, m=(b+e)/2;
-  for (; b<e; m=(b+e)/2) {
-    if (x > fLayers[m]->GetX()) b=m+1;
-    else e=m;
+  for (Int_t i = 0; i < countPos; i++) {
+    outlist[2*i  ] = sindexF[sindexS[i]+n];
+    outlist[2*i+1] = sindexF[sindexS[i]];
   }
-  return m;
-}             
 
-//______________________________________________________
-void AliTRDtracker::AliTRDpropagationLayer::SetZ(Double_t* center, Double_t *w, Double_t *wsensitive )
-{
-  //
-  // set centers and the width of sectors
-  for (Int_t icham=0;icham< AliTRDgeometry::kNcham;icham++){
-    fZc[icham] = center[icham];  
-    fZmax[icham] = w[icham];
-    fZmaxSensitive[icham] = wsensitive[icham];
-    //   printf("chamber\t%d\tzc\t%f\tzmax\t%f\tzsens\t%f\n",icham,fZc[icham],fZmax[icham],fZmaxSensitive[icham]);
-  }  
-}
-//______________________________________________________
+  delete [] sindexS;
+  delete [] sindexF;
+  
+  return countPos;
 
-void AliTRDtracker::AliTRDpropagationLayer::SetHoles(Bool_t *holes)
-{
-  //
-  // set centers and the width of sectors
-  fHole = kFALSE;
-  for (Int_t icham=0;icham< AliTRDgeometry::kNcham;icham++){
-    fIsHole[icham] = holes[icham]; 
-    if (holes[icham]) fHole = kTRUE;
-  }  
 }
 
-
-
-void AliTRDtracker::AliTRDpropagationLayer::GetPropagationParameters(
-        Double_t y, Double_t z, Double_t &dx, Double_t &rho, Double_t &radLength, 
-        Bool_t &lookForCluster) const
+//_____________________________________________________________________________
+AliTRDtrack *AliTRDtracker::RegisterSeed(AliTRDseed *seeds, Double_t *params)
 {
   //
-  // Returns radial step <dx>, density <rho>, rad. length <radLength>,
-  // and sensitivity <lookForCluster> in point <y,z>  
+  // Build a TRD track out of tracklet candidates
   //
-
-  dx  = fdX;
-  rho = fRho;
-  radLength  = fX0;
-  lookForCluster = kFALSE;
+  // Parameters :
+  //   seeds  : array of tracklets
+  //   params : track parameters (see MakeSeeds() function body for a detailed description)
   //
-  // check dead regions in sensitive volume 
-  if(fTimeBinIndex >= 0) {
-    //
-    Int_t zone=-1;
-    for(Int_t ch = 0; ch < (Int_t) kZones; ch++) {
-      if  (TMath::Abs(z - fZc[ch]) < fZmaxSensitive[ch]){ 
-       zone = ch;
-       lookForCluster = !(fIsHole[zone]);
-       if(TMath::Abs(y) > fYmaxSensitive){  
-         lookForCluster = kFALSE;
-       }
-       if (fIsHole[zone]) {
-         //if hole
-         rho = 1.29e-3;
-         radLength = 36.66;
-       }
-      }    
-    }
-    return;
-  }
+  // Output :
+  //   The TRD track.
   //
+  // Detailed description
   //
-  // check hole
-  if (fHole==kFALSE) return;
+  // To be discussed with Marian !!
   //
-  for(Int_t ch = 0; ch < (Int_t) kZones; ch++) {
-    if  (TMath::Abs(z - fZc[ch]) < fZmax[ch]){ 
-      if (fIsHole[ch]) {
-       //if hole
-       rho = 1.29e-3;
-       radLength = 36.66;
+
+       AliTRDcalibDB *cal = AliTRDcalibDB::Instance();
+       Int_t nTimeBins = cal->GetNumberOfTimeBins();
+       
+
+  Double_t alpha = AliTRDgeometry::GetAlpha();
+  Double_t shift = AliTRDgeometry::GetAlpha()/2.0;
+  Double_t c[15];
+
+  c[ 0] = 0.2;
+  c[ 1] = 0.0; c[ 2] = 2.0;
+  c[ 3] = 0.0; c[ 4] = 0.0; c[ 5] = 0.02;
+  c[ 6] = 0.0; c[ 7] = 0.0; c[ 8] = 0.0;  c[ 9] = 0.1;
+  c[10] = 0.0; c[11] = 0.0; c[12] = 0.0;  c[13] = 0.0; c[14] = params[5]*params[5]*0.01;
+
+  Int_t index = 0;
+  AliTRDcluster *cl = 0;
+
+  for (Int_t ilayer = 0; ilayer < 6; ilayer++) {
+               
+               if (seeds[ilayer].IsOK()) {
+      for (Int_t itime = nTimeBins-1; itime > 0; itime--) {
+                               if (seeds[ilayer].GetIndexes(itime) > 0) {
+                               index = seeds[ilayer].GetIndexes(itime);
+                               cl    = seeds[ilayer].GetClusters(itime);
+                                       //printf("l[%d] index[%d] tb[%d] cptr[%p]\n", ilayer, index, itime, cl);
+                                       break;
+                               }
       }
     }
+    if (index > 0) {
+      break;
+    }
   }
-  return;
-}
-
-Int_t  AliTRDtracker::AliTRDpropagationLayer::GetZone( Double_t z) const
-{
-  //
-  //
-  if (fTimeBinIndex < 0) return -20;  //unknown 
-  Int_t zone=-10;   // dead zone
-  for(Int_t ch = 0; ch < (Int_t) kZones; ch++) {
-    if(TMath::Abs(z - fZc[ch]) < fZmax[ch]) 
-      zone = ch;
+  if (cl == 0) {
+    return 0;
   }
-  return zone;
-}
 
+  AliTRDtrack *track = new AliTRDtrack(cl
+                                      ,index
+                                      ,&params[1]
+                                      ,c
+                                      ,params[0]
+                                      ,params[6]*alpha+shift);
+       // SetCluster(cl, 0); // A. Bercuci
+       track->PropagateTo(params[0]-5.0);
+  track->ResetCovariance(1);
 
-//______________________________________________________
-
-void AliTRDtracker::AliTRDpropagationLayer::InsertCluster(AliTRDcluster* c, 
-                                                          UInt_t index) {
-
-// Insert cluster in cluster array.
-// Clusters are sorted according to Y coordinate.  
-
-  if(fTimeBinIndex < 0) { 
-    printf("*** attempt to insert cluster into non-sensitive time bin!\n");
-    return;
+  Int_t rc = FollowBackProlongation(*track);
+  if (rc < 30) {
+    delete track;
+    track = 0;
   }
-
-  if (fN== (Int_t) kMaxClusterPerTimeBin) {
-    printf("AliTRDpropagationLayer::InsertCluster(): Too many clusters !\n"); 
-    return;
+  else {
+    track->CookdEdx();
+    track->CookdEdxTimBin(-1);
+    CookLabel(track,0.9);
   }
-  if (fN==0) {fIndex[0]=index; fClusters[fN++]=c; return;}
-  Int_t i=Find(c->GetY());
-  memmove(fClusters+i+1 ,fClusters+i,(fN-i)*sizeof(AliTRDcluster*));
-  memmove(fIndex   +i+1 ,fIndex   +i,(fN-i)*sizeof(UInt_t)); 
-  fIndex[i]=index; fClusters[i]=c; fN++;
-}  
 
-//______________________________________________________
+  return track;
 
-Int_t AliTRDtracker::AliTRDpropagationLayer::Find(Double_t y) const {
-
-// Returns index of the cluster nearest in Y    
+}
 
-  if (y <= fClusters[0]->GetY()) return 0;
-  if (y > fClusters[fN-1]->GetY()) return fN;
-  Int_t b=0, e=fN-1, m=(b+e)/2;
-  for (; b<e; m=(b+e)/2) {
-    if (y > fClusters[m]->GetY()) b=m+1;
-    else e=m;
+//_____________________________________________________________________________
+void AliTRDtracker::InitLogHists() 
+{
+  //
+  // Create the log histograms
+  //
+  fHBackfit  = new TH1D("logTRD_backfit" ,""
+                                         ,  40,-0.5, 39.5);  
+  fHRefit    = new TH1D("logTRD_refit"   ,""
+                                         ,  40,-0.5, 39.5);
+  fHClSearch = new TH1D("logTRD_clSearch",""
+                                         ,  60,-0.5, 59.5); 
+  
+  fHX        = new TH1D("logTRD_X"       ,";x (cm)"
+                                         , 200,  50,  400);
+  fHNCl      = new TH1D("logTRD_ncl"     ,"" 
+                                         ,  40,-0.5, 39.5);
+  fHNClTrack = new TH1D("logTRD_nclTrack",""
+                                         , 180,-0.5,179.5);
+  
+  fHMinYPos  = new TH1D("logTRD_minYPos" ,";#delta Y (cm)"
+                                         , 400,  -6,    6);
+  fHMinYNeg  = new TH1D("logTRD_minYNeg" ,";#delta Y (cm)"
+                                         , 400,  -6,    6);
+  fHMinZ     = new TH1D("logTRD_minZ"    ,";#delta Z (cm)"
+                                         , 400, -20,   20);
+  fHMinD     = new TH2D("logTRD_minD"    ,";#delta Y (cm);#delta Z (cm)"
+                                         , 100,  -6,    6
+                                         , 100, -50,   50);
+  
+  fHDeltaX   = new TH1D("logTRD_deltaX"  ,";#delta X (cm)"
+                                         , 100,  -5,    5);
+  fHXCl      = new TH1D("logTRD_xCl"     ,";cluster x position (cm)"
+                                         ,1000, 280,  380);
+  
+  const Char_t *nameFindCl[4] = { "logTRD_clY"
+                                , "logTRD_clZ"
+                                , "logTRD_clB"
+                                , "logTRD_clG" };
+  
+  for (Int_t i = 0; i < 4; i++) {
+    fHFindCl[i] = new TH1D(nameFindCl[i],"",30,-0.5,29.5);
   }
-  return m;
-}    
-
-//---------------------------------------------------------
-
-Double_t AliTRDtracker::GetTiltFactor(const AliTRDcluster* c) {
-//
-//  Returns correction factor for tilted pads geometry 
-//
-
-  Double_t h01 = sin(TMath::Pi() / 180.0 * fPar->GetTiltingAngle());
-  Int_t det = c->GetDetector();    
-  Int_t plane = fGeom->GetPlane(det);
 
-  if((plane == 1) || (plane == 3) || (plane == 5)) h01=-h01;
-
-  if(fNoTilt) h01 = 0;
-  
-  return h01;
 }
 
+//_____________________________________________________________________________
+void AliTRDtracker::SaveLogHists() 
+{
+  //
+  // Save the log histograms in AliESDs.root
+  //
 
+  TDirectory *sav     = gDirectory;
+  TFile      *logFile = 0;
 
+  TSeqCollection *col = gROOT->GetListOfFiles();
+  Int_t nn = col->GetEntries();
+  for (Int_t i = 0; i < nn; i++) {
+    logFile = (TFile *) col->At(i);
+    if (strstr(logFile->GetName(),"AliESDs.root")) {
+      break;
+    }
+  }
+   
+  logFile->cd();
+
+  fHBackfit->Write(fHBackfit->GetName(),TObject::kOverwrite);
+  fHRefit->Write(fHRefit->GetName(),TObject::kOverwrite);
+  fHClSearch->Write(fHClSearch->GetName(),TObject::kOverwrite);
+  fHX->Write(fHX->GetName(),TObject::kOverwrite);
+  fHNCl->Write(fHNCl->GetName(),TObject::kOverwrite);
+  fHNClTrack->Write(fHNClTrack->GetName(),TObject::kOverwrite);
+
+  fHMinYPos->Write(fHMinYPos->GetName(),TObject::kOverwrite);
+  fHMinYNeg->Write(fHMinYNeg->GetName(),TObject::kOverwrite);
+  fHMinD->Write(fHMinD->GetName(),TObject::kOverwrite);
+  fHMinZ->Write(fHMinZ->GetName(),TObject::kOverwrite);
+  
+  fHDeltaX->Write(fHDeltaX->GetName(),TObject::kOverwrite);
+  fHXCl->Write(fHXCl->GetName(),TObject::kOverwrite);
 
+  for (Int_t i = 0; i < 4; i++) {
+    fHFindCl[i]->Write(fHFindCl[i]->GetName(),TObject::kOverwrite);
+  }
 
+  logFile->Flush();
+  
+  sav->cd();
 
+}