]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TRD/AliTRDv1.cxx
running local for SP and LYZEP and new histograms for QC
[u/mrichter/AliRoot.git] / TRD / AliTRDv1.cxx
index c06dbc7bbafc13d9be007068456adde721df189b..6056c4539565cb0761d48c904416f01a973fa544 100644 (file)
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
 
-/*
-$Log$
-Revision 1.12  1999/11/02 16:35:56  fca
-New version of TRD introduced
-
-Revision 1.11  1999/11/01 20:41:51  fca
-Added protections against using the wrong version of FRAME
-
-Revision 1.10  1999/09/29 09:24:35  fca
-Introduction of the Copyright and cvs Log
-
-*/
-
-///////////////////////////////////////////////////////////////////////////////
-//                                                                           //
-//  Transition Radiation Detector version 2 -- slow simulator                //
-//                                                                           //
-//Begin_Html
-/*
-<img src="picts/AliTRDfullClass.gif">
-*/
-//End_Html
-//                                                                           //
-//                                                                           //
-///////////////////////////////////////////////////////////////////////////////
+/* $Id$ */
 
+////////////////////////////////////////////////////////////////////////////
+//                                                                        //
+//  Transition Radiation Detector version 1 -- slow simulator             //
+//                                                                        //
+////////////////////////////////////////////////////////////////////////////
+
+#include <stdlib.h> 
+
+#include <TF1.h>
+#include <TLorentzVector.h>
 #include <TMath.h>
-#include <TVector.h>
 #include <TRandom.h>
+#include <TVector.h>
+#include <TVirtualMC.h>
+#include <TGeoManager.h>
+#include <TGeoMatrix.h>
+#include <TGeoPhysicalNode.h>
 
-#include "AliTRDv1.h"
-#include "AliTRDmatrix.h"
-#include "AliRun.h"
-#include "AliMC.h"
 #include "AliConst.h"
+#include "AliLog.h"
+#include "AliTrackReference.h"
+#include "AliMC.h"
+#include "AliRun.h"
+#include "AliGeomManager.h"
 
-ClassImp(AliTRDv1)
+#include "AliTRDgeometry.h"
+#include "AliTRDSimParam.h"
+#include "AliTRDhit.h"
+#include "AliTRDsimTR.h"
+#include "AliTRDv1.h"
 
+ClassImp(AliTRDv1)
 //_____________________________________________________________________________
-AliTRDv1::AliTRDv1(const char *name, const char *title) 
-         :AliTRD(name, title) 
+AliTRDv1::AliTRDv1()
+  :AliTRD()
+  ,fTRon(kFALSE)
+  ,fTR(NULL)
+  ,fTypeOfStepManager(0)
+  ,fStepSize(0)
+  ,fWion(0)
+  ,fDeltaE(NULL)
+  ,fDeltaG(NULL)
+  ,fTrackLength0(0)
+  ,fPrimaryTrackPid(0)
 {
   //
-  // Standard constructor for Transition Radiation Detector version 2
+  // Default constructor
   //
 
-  fIdSens        = 0;
-
-  fIdChamber1    = 0;
-  fIdChamber2    = 0;
-  fIdChamber3    = 0;
-
-  fSensSelect    = 0;
-  fSensPlane     = 0;
-  fSensChamber   = 0;
-  fSensSector    = 0;
-
-  fGasGain       = 0;
-  fNoise         = 0;
-  fChipGain      = 0;
-  fADCoutRange   = 0;
-  fADCinRange    = 0;
-  fADCthreshold  = 0;
-
-  fDiffusionT    = 0;
-  fDiffusionL    = 0;
-
-  fClusMaxThresh = 0;
-  fClusSigThresh = 0;
-  fClusMethod    = 0;
-
-  fDeltaE        = NULL;
-
-  SetBufferSize(128000);
-
 }
 
 //_____________________________________________________________________________
-AliTRDv1::~AliTRDv1()
-{
-
-  if (fDeltaE) delete fDeltaE;
-
-}
-//_____________________________________________________________________________
-void AliTRDv1::CreateGeometry()
+AliTRDv1::AliTRDv1(const char *name, const char *title) 
+  :AliTRD(name,title) 
+  ,fTRon(kTRUE)
+  ,fTR(NULL)
+  ,fTypeOfStepManager(2)
+  ,fStepSize(0.1)
+  ,fWion(0)
+  ,fDeltaE(NULL)
+  ,fDeltaG(NULL)
+  ,fTrackLength0(0)
+  ,fPrimaryTrackPid(0)
 {
   //
-  // Create the GEANT geometry for the Transition Radiation Detector - Version 2
-  // This version covers the full azimuth. 
+  // Standard constructor for Transition Radiation Detector version 1
   //
 
-  // Check that FRAME is there otherwise we have no place where to put the TRD
-  AliModule* FRAME = gAlice->GetModule("FRAME");
-  if (!FRAME) return;
+  SetBufferSize(128000);
 
-  // Define the chambers
-  AliTRD::CreateGeometry();
+  if      (AliTRDSimParam::Instance()->IsXenon()) {
+    fWion = 23.53; // Ionization energy XeCO2 (85/15)
+  }
+  else if (AliTRDSimParam::Instance()->IsArgon()) {
+    fWion = 27.21; // Ionization energy ArCO2 (82/18)
+  }
+  else {
+    AliFatal("Wrong gas mixture");
+    exit(1);
+  }
 
 }
 
 //_____________________________________________________________________________
-void AliTRDv1::CreateMaterials()
+AliTRDv1::~AliTRDv1()
 {
   //
-  // Create materials for the Transition Radiation Detector version 2
+  // AliTRDv1 destructor
   //
 
-  AliTRD::CreateMaterials();
+  if (fDeltaE) {
+    delete fDeltaE;
+    fDeltaE = 0;
+  }
 
-}
+  if (fDeltaG) {
+    delete fDeltaG;
+    fDeltaG = 0;
+  }
+
+  if (fTR) {
+    delete fTR;
+    fTR     = 0;
+  }
 
+}
 //_____________________________________________________________________________
-void AliTRDv1::Diffusion(Float_t driftlength, Float_t *xyz)
+void AliTRDv1::AddAlignableVolumes() const
 {
   //
-  // Applies the diffusion smearing to the position of a single electron
+  // Create entries for alignable volumes associating the symbolic volume
+  // name with the corresponding volume path. Needs to be syncronized with
+  // eventual changes in the geometry.
   //
 
-  if ((driftlength >        0) && 
-      (driftlength < kDrThick)) {
-    Float_t driftSqrt = TMath::Sqrt(driftlength);
-    Float_t sigmaT = driftSqrt * fDiffusionT;
-    Float_t sigmaL = driftSqrt * fDiffusionL;
-    xyz[0] = gRandom->Gaus(xyz[0], sigmaL);
-    xyz[1] = gRandom->Gaus(xyz[1], sigmaT);
-    xyz[2] = gRandom->Gaus(xyz[2], sigmaT);
-  }
-  else {
-    xyz[0] = 0.0;
-    xyz[1] = 0.0;
-    xyz[2] = 0.0;
-  }
+  TString volPath;
+  TString symName;
 
-}
+  TString vpStr   = "ALIC_1/B077_1/BSEGMO";
+  TString vpApp1  = "_1/BTRD";
+  TString vpApp2  = "_1";
+  TString vpApp3a = "/UTR1_1/UTS1_1/UTI1_1/UT";
+  TString vpApp3b = "/UTR2_1/UTS2_1/UTI2_1/UT";
+  TString vpApp3c = "/UTR3_1/UTS3_1/UTI3_1/UT";
+
+  TString snStr   = "TRD/sm";
+  TString snApp1  = "/st";
+  TString snApp2  = "/pl";
 
-//_____________________________________________________________________________
-void AliTRDv1::Hits2Digits()
-{
   //
-  // Creates TRD digits from hits. This procedure includes the following:
-  //      - Diffusion
-  //      - Gas gain including fluctuations
-  //      - Pad-response (simple Gaussian approximation)
-  //      - Electronics noise
-  //      - Electronics gain
-  //      - Digitization
-  //      - ADC threshold
-  // The corresponding parameter can be adjusted via the various Set-functions.
-  // If these parameters are not explicitly set, default values are used (see
-  // Init-function).
-  // To produce digits from a root-file with TRD-hits use the
-  // slowDigitsCreate.C macro.
+  // The super modules
+  // The symbolic names are: TRD/sm00
+  //                           ...
+  //                         TRD/sm17
   //
+  for (Int_t isector = 0; isector < AliTRDgeometry::Nsector(); isector++) {
 
-  printf("AliTRDv1::Hits2Digits -- Start creating digits\n");
-
-  ///////////////////////////////////////////////////////////////
-  // Parameter 
-  ///////////////////////////////////////////////////////////////
-
-  // Converts number of electrons to fC
-  const Float_t el2fC = 1.602E-19 * 1.0E15; 
-
-  ///////////////////////////////////////////////////////////////
-
-  Int_t nBytes = 0;
-
-  Int_t iRow;
-
-  AliTRDhit *TRDhit;
-
-  // Get the pointer to the hit tree
-  TTree *HitTree    = gAlice->TreeH();
-  // Get the pointer to the digits tree
-  TTree *DigitsTree = gAlice->TreeD();
-
-  // Get the number of entries in the hit tree
-  // (Number of primary particles creating a hit somewhere)
-  Int_t nTrack = (Int_t) HitTree->GetEntries();
-
-  Int_t chamBeg = 0;
-  Int_t chamEnd = kNcham;
-  if (fSensChamber) chamEnd = chamBeg = fSensChamber;
-  Int_t planBeg = 0;
-  Int_t planEnd = kNplan;
-  if (fSensPlane)   planEnd = planBeg = fSensPlane;
-  Int_t sectBeg = 0;
-  Int_t sectEnd = kNsect;
-  if (fSensSector)  sectEnd = sectBeg = fSensSector;
-
-  // Loop through all the chambers
-  for (Int_t icham = chamBeg; icham < chamEnd; icham++) {
-    for (Int_t iplan = planBeg; iplan < planEnd; iplan++) {
-      for (Int_t isect = sectBeg; isect < sectEnd; isect++) {
-
-        Int_t nDigits = 0;
-
-        printf("AliTRDv1::Hits2Digits -- Digitizing chamber %d, plane %d, sector %d\n"
-              ,icham+1,iplan+1,isect+1);
-
-        // Create a detector matrix to keep the signal and track numbers
-        AliTRDmatrix *matrix = new AliTRDmatrix(fRowMax[iplan][icham][isect]
-                                               ,fColMax[iplan]
-                                               ,fTimeMax
-                                               ,isect+1,icham+1,iplan+1);
-
-        // Loop through all entries in the tree
-        for (Int_t iTrack = 0; iTrack < nTrack; iTrack++) {
-
-          gAlice->ResetHits();
-          nBytes += HitTree->GetEvent(iTrack);
-
-          // Get the number of hits in the TRD created by this particle
-          Int_t nHit = fHits->GetEntriesFast();
-
-          // Loop through the TRD hits  
-          for (Int_t iHit = 0; iHit < nHit; iHit++) {
-
-            if (!(TRDhit = (AliTRDhit *) fHits->UncheckedAt(iHit))) 
-              continue;
-
-            Float_t x       = TRDhit->fX;
-            Float_t y       = TRDhit->fY;
-            Float_t z       = TRDhit->fZ;
-            Float_t q       = TRDhit->fQ;
-            Int_t   track   = TRDhit->fTrack;
-            Int_t   plane   = TRDhit->fPlane;
-            Int_t   sector  = TRDhit->fSector;
-            Int_t   chamber = TRDhit->fChamber;        
-
-            if ((sector  != isect+1) ||
-                (plane   != iplan+1) ||
-                (chamber != icham+1)) 
-              continue;
-
-            // Rotate the sectors on top of each other
-            Float_t phi  = 2.0 * kPI /  (Float_t) kNsect 
-                               * ((Float_t) sector - 0.5);
-            Float_t xRot = -x * TMath::Cos(phi) + y * TMath::Sin(phi);
-            Float_t yRot =  x * TMath::Sin(phi) + y * TMath::Cos(phi);
-            Float_t zRot =  z;
-
-            // The hit position in pad coordinates (center pad)
-            // The pad row (z-direction)
-            Int_t rowH  = (Int_t) ((zRot -  fRow0[iplan][icham][isect]) / fRowPadSize);
-            // The pad column (rphi-direction)  
-            Int_t colH  = (Int_t) ((yRot -  fCol0[iplan]              ) / fColPadSize);
-            // The time bucket
-            Int_t timeH = (Int_t) ((xRot - fTime0[iplan]              ) / fTimeBinSize);
-
-            // Array to sum up the signal in a box surrounding the
-            // hit postition
-            const Int_t timeBox = 5;
-            const Int_t  colBox = 7;
-            const Int_t  rowBox = 5;
-            Float_t signalSum[rowBox][colBox][timeBox];
-            for (iRow  = 0;  iRow <  rowBox; iRow++ ) {
-              for (Int_t iCol  = 0;  iCol <  colBox; iCol++ ) {
-                for (Int_t iTime = 0; iTime < timeBox; iTime++) {
-                  signalSum[iRow][iCol][iTime] = 0;
-               }
-             }
-           }
-
-            // Loop over all electrons of this hit
-            Int_t nEl = (Int_t) q;
-            for (Int_t iEl = 0; iEl < nEl; iEl++) {
-
-              // Apply the diffusion smearing
-              Float_t driftlength = xRot - fTime0[iplan];
-              Float_t xyz[3];
-              xyz[0] = xRot;
-              xyz[1] = yRot;
-              xyz[2] = zRot;
-              Diffusion(driftlength,xyz);
-
-              // At this point absorption effects that depend on the 
-             // driftlength could be taken into account.              
-
-              // The electron position and the distance to the hit position
-             // in pad units
-              // The pad row (z-direction)
-              Int_t  rowE = (Int_t) ((xyz[2] -  fRow0[iplan][icham][isect]) / fRowPadSize);
-              Int_t  rowD =  rowH -  rowE;
-              // The pad column (rphi-direction)
-              Int_t  colE = (Int_t) ((xyz[1] -  fCol0[iplan]              ) / fColPadSize);
-              Int_t  colD =  colH -  colE;
-              // The time bucket
-              Int_t timeE = (Int_t) ((xyz[0] - fTime0[iplan]              ) / fTimeBinSize);
-              Int_t timeD = timeH - timeE;
-
-              // Apply the gas gain including fluctuations
-              Int_t signal = (Int_t) (-fGasGain * TMath::Log(gRandom->Rndm()));
-
-             // The distance of the electron to the center of the pad 
-             // in units of pad width
-              Float_t dist = (xyz[1] - fCol0[iplan] - (colE + 0.5) * fColPadSize) 
-                           / fColPadSize;
-
-              // Sum up the signal in the different pixels
-              // and apply the pad response
-              Int_t  rowIdx =  rowD + (Int_t) ( rowBox / 2);
-              Int_t  colIdx =  colD + (Int_t) ( colBox / 2);
-              Int_t timeIdx = timeD + (Int_t) (timeBox / 2);
-              signalSum[rowIdx][colIdx-1][timeIdx] += PadResponse(dist-1.) * signal;
-              signalSum[rowIdx][colIdx  ][timeIdx] += PadResponse(dist   ) * signal;
-              signalSum[rowIdx][colIdx+1][timeIdx] += PadResponse(dist+1.) * signal;
+    volPath  = vpStr;
+    volPath += isector;
+    volPath += vpApp1;
+    volPath += isector;
+    volPath += vpApp2;
 
-            }
+    symName  = snStr;
+    symName += Form("%02d",isector);
 
-            // Add the padcluster to the detector matrix
-            for (iRow  = 0;  iRow <  rowBox; iRow++ ) {
-              for (Int_t iCol  = 0;  iCol <  colBox; iCol++ ) {
-                for (Int_t iTime = 0; iTime < timeBox; iTime++) {
+    gGeoManager->SetAlignableEntry(symName.Data(),volPath.Data());
 
-                  Int_t  rowB =  rowH + iRow  - (Int_t) ( rowBox / 2); 
-                  Int_t  colB =  colH + iCol  - (Int_t) ( colBox / 2);
-                  Int_t timeB = timeH + iTime - (Int_t) (timeBox / 2);
+  }
 
-                  Float_t signalB = signalSum[iRow][iCol][iTime];
-                  if (signalB > 0.0) {
-                    matrix->AddSignal(rowB,colB,timeB,signalB);
-                    if (!(matrix->AddTrack(rowB,colB,timeB,track))) 
-                      printf(" More than three tracks in a pixel!\n");
-                 }
+  //
+  // The readout chambers
+  // The symbolic names are: TRD/sm00/st0/pl0
+  //                           ...
+  //                         TRD/sm17/st4/pl5
+  //
+  AliGeomManager::ELayerID idTRD1 = AliGeomManager::kTRD1;
+  Int_t layer, modUID;
+  
+  for (Int_t isector = 0; isector < AliTRDgeometry::Nsector(); isector++) {
 
-               }
-             }
-           }
+    if (fGeometry->GetSMstatus(isector) == 0) continue;
 
-          }
+    for (Int_t istack = 0; istack < AliTRDgeometry::Nstack(); istack++) {
+      for (Int_t ilayer = 0; ilayer < AliTRDgeometry::Nlayer(); ilayer++) {
 
-       }
+       layer = idTRD1 + ilayer;
+       modUID = AliGeomManager::LayerToVolUIDSafe(layer,isector*5+istack);
 
-        // Create the hits for this chamber
-        for (Int_t iRow  = 0; iRow  <  fRowMax[iplan][icham][isect]; iRow++ ) {
-          for (Int_t iCol  = 0; iCol  <  fColMax[iplan]              ; iCol++ ) {
-            for (Int_t iTime = 0; iTime < fTimeMax                     ; iTime++) {         
-
-              Float_t signalAmp = matrix->GetSignal(iRow,iCol,iTime);
-
-              // Add the noise
-              signalAmp  = TMath::Max(gRandom->Gaus(signalAmp,fNoise),(Float_t) 0.0);
-             // Convert to fC
-              signalAmp *= el2fC;
-              // Convert to mV
-              signalAmp *= fChipGain;
-             // Convert to ADC counts
-              Int_t adc  = (Int_t) (signalAmp * (fADCoutRange / fADCinRange));
-
-             // Apply threshold on ADC value
-              if (adc > fADCthreshold) {
-
-                Int_t trackSave[3];
-                for (Int_t ii = 0; ii < 3; ii++) {
-                  trackSave[ii] = matrix->GetTrack(iRow,iCol,iTime,ii);
-               }
-
-                Int_t digits[7];
-                digits[0] = matrix->GetSector();
-                digits[1] = matrix->GetChamber();
-                digits[2] = matrix->GetPlane();
-                digits[3] = iRow;
-                digits[4] = iCol;
-                digits[5] = iTime;
-                digits[6] = adc;
-
-               // Add this digit to the TClonesArray
-                AddDigit(trackSave,digits);
-                nDigits++;
-
-             }
-
-           }
+        Int_t idet = AliTRDgeometry::GetDetectorSec(ilayer,istack);
+
+        volPath  = vpStr;
+        volPath += isector;
+        volPath += vpApp1;
+        volPath += isector;
+        volPath += vpApp2;
+        switch (isector) {
+        case 13:
+        case 14:
+        case 15:
+          if (istack == 2) {
+            continue;
          }
+          volPath += vpApp3c;
+          break;
+        case 11:
+        case 12:
+          volPath += vpApp3b;
+          break;
+        default:
+          volPath += vpApp3a;
+       };
+        volPath += Form("%02d",idet);
+        volPath += vpApp2;
+
+        symName  = snStr;
+        symName += Form("%02d",isector);
+        symName += snApp1;
+        symName += istack;
+        symName += snApp2;
+        symName += ilayer;
+
+        TGeoPNEntry *alignableEntry = 
+         gGeoManager->SetAlignableEntry(symName.Data(),volPath.Data(),modUID);
+
+       // Add the tracking to local matrix following the TPC example
+       if (alignableEntry) {
+         // Is this correct still????
+         TGeoHMatrix *globMatrix = alignableEntry->GetGlobalOrig();
+         Double_t sectorAngle = 20.0 * (isector % 18) + 10.0;
+         TGeoHMatrix *t2lMatrix  = new TGeoHMatrix();
+         t2lMatrix->RotateZ(sectorAngle);
+         t2lMatrix->MultiplyLeft(&(globMatrix->Inverse()));
+         alignableEntry->SetMatrix(t2lMatrix);
+       }
+       else {
+         AliError(Form("Alignable entry %s is not valid!",symName.Data()));
        }
-
-        printf("AliTRDv1::Hits2Digits -- Number of digits found: %d\n",nDigits);
-
-       // Clean up
-        delete matrix;
 
       }
     }
   }
 
-  // Fill the digits-tree
-  printf("AliTRDv1::Hits2Digits -- Fill the digits tree\n");
-  DigitsTree->Fill();
+}
+
+//_____________________________________________________________________________
+void AliTRDv1::CreateGeometry()
+{
+  //
+  // Create the GEANT geometry for the Transition Radiation Detector - Version 1
+  // This version covers the full azimuth. 
+  //
+
+  // Check that FRAME is there otherwise we have no place where to put the TRD
+  AliModule* frame = gAlice->GetModule("FRAME");
+  if (!frame) {
+    AliError("TRD needs FRAME to be present\n");
+    return;
+  }
+
+  // Define the chambers
+  AliTRD::CreateGeometry();
 
 }
 
 //_____________________________________________________________________________
-void AliTRDv1::Digits2Clusters()
+void AliTRDv1::CreateMaterials()
 {
+  //
+  // Create materials for the Transition Radiation Detector version 1
+  //
+
+  AliTRD::CreateMaterials();
+
+}
 
+//_____________________________________________________________________________
+void AliTRDv1::CreateTRhit(Int_t det)
+{
   //
-  // Method to convert AliTRDdigits created by AliTRDv1::Hits2Digits()
-  // into AliTRDclusters
-  // To produce cluster from a root-file with TRD-digits use the
-  // slowClusterCreate.C macro.
+  // Creates an electron cluster from a TR photon.
+  // The photon is assumed to be created a the end of the radiator. The 
+  // distance after which it deposits its energy takes into account the 
+  // absorbtion of the entrance window and of the gas mixture in drift
+  // volume.
   //
-  
-  Int_t row
-
-  printf("AliTRDv1::Digits2Clusters -- Start creating clusters\n");
-
-  AliTRDdigit  *TRDdigit;
-  TClonesArray *TRDDigits;
-
-  // Parameters
-  Float_t maxThresh        = fClusMaxThresh;   // threshold value for maximum
-  Float_t signalThresh     = fClusSigThresh;   // threshold value for digit signal
-  Int_t   clusteringMethod = fClusMethod;      // clustering method option (for testing)
-
-  const Float_t epsilon    = 0.01;             // iteration limit for unfolding procedure
-
-  // Get the pointer to the digits tree
-  TTree *DigitTree   = gAlice->TreeD();
-  // Get the pointer to the cluster tree
-  TTree *ClusterTree = gAlice->TreeD();
-
-  // Get the pointer to the digits container
-  TRDDigits = Digits();
-
-  Int_t chamBeg = 0;
-  Int_t chamEnd = kNcham;
-  if (fSensChamber) chamEnd = chamBeg = fSensChamber;
-  Int_t planBeg = 0;
-  Int_t planEnd = kNplan;
-  if (fSensPlane)   planEnd = planBeg = fSensPlane;
-  Int_t sectBeg = 0;
-  Int_t sectEnd = kNsect;
-  if (fSensSector)  sectEnd = sectBeg = fSensSector;
-
-  // Import the digit tree
-  gAlice->ResetDigits();
-  Int_t nbytes;
-  nbytes += DigitTree->GetEvent(1);
-
-  // Get the number of digits in the detector
-  Int_t nTRDDigits = TRDDigits->GetEntriesFast();
-
-  // *** Start clustering *** in every chamber
-  for (Int_t icham = chamBeg; icham < chamEnd; icham++) {
-    for (Int_t iplan = planBeg; iplan < planEnd; iplan++) {
-      for (Int_t isect = sectBeg; isect < sectEnd; isect++) {
-
-        Int_t nClusters = 0;
-        printf("AliTRDv1::Digits2Clusters -- Finding clusters in chamber %d, plane %d, sector %d\n"
-               ,icham+1,iplan+1,isect+1);
-
-        // Create a detector matrix to keep maxima
-        AliTRDmatrix *digitMatrix = new AliTRDmatrix(fRowMax[iplan][icham][isect]
-                                                     ,fColMax[iplan]
-                                                     ,fTimeMax,isect+1
-                                                     ,icham+1,iplan+1);
-        // Create a matrix to contain maximum flags
-        AliTRDmatrix *maximaMatrix = new AliTRDmatrix(fRowMax[iplan][icham][isect]
-                                                      ,fColMax[iplan]
-                                                      ,fTimeMax
-                                                      ,isect+1,icham+1,iplan+1);
-
-        // Loop through all TRD digits
-        for (Int_t iTRDDigits = 0; iTRDDigits < nTRDDigits; iTRDDigits++) {
-
-          // Get the information for this digit
-          TRDdigit = (AliTRDdigit*) TRDDigits->UncheckedAt(iTRDDigits);
-          Int_t   signal  = TRDdigit->fSignal;
-          Int_t   sector  = TRDdigit->fSector;
-          Int_t   chamber = TRDdigit->fChamber;
-          Int_t   plane   = TRDdigit->fPlane;
-          Int_t   row     = TRDdigit->fRow;
-          Int_t   col     = TRDdigit->fCol;
-          Int_t   time    = TRDdigit->fTime;
-
-          Int_t   track[3];
-          for (Int_t iTrack = 0; iTrack < 3; iTrack++) {
-            track[iTrack]  = TRDdigit->AliDigit::fTracks[iTrack];
-          }
 
-          if ((sector  != isect+1) ||
-              (plane   != iplan+1) ||
-              (chamber != icham+1))
-            continue;
+  // Maximum number of TR photons per track
+  const Int_t   kNTR         = 50;
 
-          // Fill the detector matrix
-          if (signal > signalThresh) {
-            digitMatrix->SetSignal(row,col,time,signal);
-            for (Int_t iTrack = 0; iTrack < 3; iTrack++) {
-              if (track[iTrack] > 0) {
-                digitMatrix->AddTrack(row,col,time,track[iTrack]);
-              }
-            }
-          }
+  TLorentzVector mom;
+  TLorentzVector pos;
 
-        }
+  Float_t eTR[kNTR];
+  Int_t   nTR;
 
-        // Loop chamber and find maxima in digitMatrix
-        for (row = 0;  row < fRowMax[iplan][icham][isect];  row++) {
-          for (Int_t  col = 1;  col < fColMax[iplan]              ;  col++) {
-            for (Int_t time = 0; time < fTimeMax                    ; time++) {
-
-              if (digitMatrix->GetSignal(row,col,time) 
-                  < digitMatrix->GetSignal(row,col - 1,time)) {
-                // really maximum?
-                if (col > 1) {
-                  if (digitMatrix->GetSignal(row,col - 2,time)
-                      < digitMatrix->GetSignal(row,col - 1,time)) {
-                    // yes, so set maximum flag
-                    maximaMatrix->SetSignal(row,col - 1,time,1);
-                  }
-                  else maximaMatrix->SetSignal(row,col - 1,time,0);
-                }
-              }
-
-            }   // time
-          }     // col
-        }       // row
-
-        // now check maxima and calculate cluster position
-        for (row = 0;  row < fRowMax[iplan][icham][isect];  row++) {
-          for (Int_t  col = 1;  col < fColMax[iplan]              ;  col++) {
-            for (Int_t time = 0; time < fTimeMax                    ; time++) {
-
-              if ((maximaMatrix->GetSignal(row,col,time) > 0)
-                  && (digitMatrix->GetSignal(row,col,time) > maxThresh)) {
-
-                Int_t   clusters[5]        = {0};   // cluster-object data
-
-                Float_t ratio              =  0;    // ratio resulting from unfolding
-                Float_t padSignal[5]       = {0};   // signals on max and neighbouring pads
-                Float_t clusterSignal[3]   = {0};   // signals from cluster
-                Float_t clusterPos[3]      = {0};   // cluster in ALICE refFrame coords
-                Float_t clusterPads[6]     = {0};   // cluster pad info
-
-                // setting values
-                clusters[0] = isect+1;    // = isect ????
-                clusters[1] = icham+1;    // = ichamber ????
-                clusters[2] = iplan+1;    // = iplane ????
-                clusters[3] = time;
-
-                clusterPads[0] = icham+1;
-                clusterPads[1] = isect+1;
-                clusterPads[2] = iplan+1;
-
-                for (Int_t iPad = 0; iPad < 3; iPad++) {
-                  clusterSignal[iPad] = digitMatrix->GetSignal(row,col-1+iPad,time);
-                }
-
-                // neighbouring maximum on right side?
-                if (col < fColMax[iplan] - 2) {
-                  if (maximaMatrix->GetSignal(row,col + 2,time) > 0) {
-                    for (Int_t iPad = 0; iPad < 5; iPad++) {
-                      padSignal[iPad] = digitMatrix->GetSignal(row,col-1+iPad,time);
-                    }
-
-                    // unfold:
-                    ratio = Unfold(epsilon, padSignal);
-
-                    // set signal on overlapping pad to ratio
-                    clusterSignal[2] *= ratio;
-                  }
-                }
-
-                switch (clusteringMethod) {
-                case 1:
-                  // method 1: simply center of mass
-                  clusterPads[3] = row + 0.5;
-                  clusterPads[4] = col - 0.5 + (clusterSignal[2] - clusterSignal[0]) /
-                                   (clusterSignal[1] + clusterSignal[2] + clusterSignal[3]);
-                  clusterPads[5] = time + 0.5;
-
-                  nClusters++;
-                  break;
-                case 2:
-                  // method 2: integral gauss fit on 3 pads
-                  TH1F *hPadCharges = new TH1F("hPadCharges", "Charges on center 3 pads"
-                                                           , 5, -1.5, 3.5);
-                  for (Int_t iCol = -1; iCol <= 3; iCol++) {
-                    if (clusterSignal[iCol] < 1) clusterSignal[iCol] = 1;
-                    hPadCharges->Fill(iCol, clusterSignal[iCol]);
-                  }
-                  hPadCharges->Fit("gaus", "IQ", "SAME", -0.5, 2.5);
-                  TF1     *fPadChargeFit = hPadCharges->GetFunction("gaus");
-                  Double_t  colMean = fPadChargeFit->GetParameter(1);
-
-                  clusterPads[3] = row + 0.5;
-                  clusterPads[4] = col - 1.5 + colMean;
-                  clusterPads[5] = time + 0.5;
-
-                  delete hPadCharges;
-
-                  nClusters++;
-                  break;
-                }
-
-                Float_t clusterCharge =   clusterSignal[0]
-                                        + clusterSignal[1]
-                                        + clusterSignal[2];
-                clusters[4] = (Int_t)clusterCharge;
-
-                Int_t trackSave[3];
-                for (Int_t iTrack = 0; iTrack < 3; iTrack++) {
-                  trackSave[iTrack] = digitMatrix->GetTrack(row,col,time,iTrack);
-                }
-
-                // Calculate cluster position in ALICE refFrame coords
-                // and set array clusterPos to calculated values
-                Pads2XYZ(clusterPads, clusterPos);
-
-                // Add cluster to reconstruction tree
-                AddCluster(trackSave,clusters,clusterPos);
-
-              }
-
-            }  // time
-          }    // col
-        }      // row
-
-        printf("AliTRDv1::Digits2Clusters -- Number of clusters found: %d\n",nClusters);
-
-        delete digitMatrix;
-        delete maximaMatrix;
-
-      }          // isect
-    }            // iplan
-  }              // icham
-
-  // Fill the cluster-tree
-  printf("AliTRDv1::Digits2Clusters -- Total number of clusters found: %d\n"
-        ,fClusters->GetEntries());
-  printf("AliTRDv1::Digits2Clusters -- Fill the cluster tree\n");
-  ClusterTree->Fill();
+  // Create TR photons
+  gMC->TrackMomentum(mom);
+  Float_t pTot = mom.Rho();
+  fTR->CreatePhotons(11,pTot,nTR,eTR);
+  if (nTR > kNTR) {
+    AliFatal(Form("Boundary error: nTR = %d, kNTR = %d",nTR,kNTR));
+  }
+
+  // Loop through the TR photons
+  for (Int_t iTR = 0; iTR < nTR; iTR++) {
+
+    Float_t energyMeV = eTR[iTR] * 0.001;
+    Float_t energyeV  = eTR[iTR] * 1000.0;
+    Float_t absLength = 0.0;
+    Float_t sigma     = 0.0;
+
+    // Take the absorbtion in the entrance window into account
+    Double_t muMy = fTR->GetMuMy(energyMeV);
+    sigma         = muMy * fFoilDensity;
+    if (sigma > 0.0) {
+      absLength = gRandom->Exp(1.0/sigma);
+      if (absLength < AliTRDgeometry::MyThick()) {
+        continue;
+      }
+    }
+    else {
+      continue;
+    }
+
+    // The absorbtion cross sections in the drift gas
+    // Gas-mixture (Xe/CO2)
+    Double_t muNo = 0.0;
+    if      (AliTRDSimParam::Instance()->IsXenon()) {
+      muNo = fTR->GetMuXe(energyMeV);
+    }
+    else if (AliTRDSimParam::Instance()->IsArgon()) {
+      muNo = fTR->GetMuAr(energyMeV);
+    }
+    Double_t muCO = fTR->GetMuCO(energyMeV);
+    sigma = (fGasNobleFraction * muNo + (1.0 - fGasNobleFraction) * muCO) 
+          * fGasDensity 
+          * fTR->GetTemp();
+
+    // The distance after which the energy of the TR photon
+    // is deposited.
+    if (sigma > 0.0) {
+      absLength = gRandom->Exp(1.0/sigma);
+      if (absLength > (AliTRDgeometry::DrThick()
+                     + AliTRDgeometry::AmThick())) {
+        continue;
+      }
+    }
+    else {
+      continue;
+    }
+
+    // The position of the absorbtion
+    Float_t posHit[3];
+    gMC->TrackPosition(pos);
+    posHit[0] = pos[0] + mom[0] / pTot * absLength;
+    posHit[1] = pos[1] + mom[1] / pTot * absLength;
+    posHit[2] = pos[2] + mom[2] / pTot * absLength;
+
+    // Create the charge 
+    Int_t q = ((Int_t) (energyeV / fWion));
+
+    // Add the hit to the array. TR photon hits are marked 
+    // by negative charge
+    AddHit(gAlice->GetMCApp()->GetCurrentTrackNumber()
+          ,det
+          ,posHit
+          ,-q
+          ,gMC->TrackTime()*1.0e06
+          ,kTRUE);
+
+  }
 
 }
 
@@ -657,184 +377,402 @@ void AliTRDv1::Init()
 {
   //
   // Initialise Transition Radiation Detector after geometry has been built.
-  // Includes the default settings of all parameter for the digitization.
   //
 
   AliTRD::Init();
 
-  printf("          Slow simulator\n");
-  if (fSensPlane)
-    printf("          Only plane %d is sensitive\n",fSensPlane);
-  if (fSensChamber)   
-    printf("          Only chamber %d is sensitive\n",fSensChamber);
-  if (fSensSector)
-    printf("          Only sector %d is sensitive\n",fSensSector);
+  AliDebug(1,"Slow simulator\n");
 
-  // First ionization potential (eV) for the gas mixture (90% Xe + 10% CO2)
+  // Switch on TR simulation as default
+  if (!fTRon) {
+    AliInfo("TR simulation off");
+  }
+  else {
+    fTR = new AliTRDsimTR();
+  }
+
+  // First ionization potential (eV) for the gas mixture
   const Float_t kPoti = 12.1;
   // Maximum energy (50 keV);
   const Float_t kEend = 50000.0;
   // Ermilova distribution for the delta-ray spectrum
-  Float_t Poti = TMath::Log(kPoti);
-  Float_t Eend = TMath::Log(kEend);
-  fDeltaE  = new TF1("deltae",Ermilova,Poti,Eend,0);
-
-  // Identifier of the sensitive volume (drift region)
-  fIdSens     = gMC->VolId("UL05");
-
-  // Identifier of the TRD-driftchambers
-  fIdChamber1 = gMC->VolId("UCIO");
-  fIdChamber2 = gMC->VolId("UCIM");
-  fIdChamber3 = gMC->VolId("UCII");
-
-  // The default parameter for the digitization
-  if (!(fGasGain))       fGasGain       = 2.0E3;
-  if (!(fNoise))         fNoise         = 3000.;
-  if (!(fChipGain))      fChipGain      = 10.;
-  if (!(fADCoutRange))   fADCoutRange   = 255.;
-  if (!(fADCinRange))    fADCinRange    = 2000.;
-  if (!(fADCthreshold))  fADCthreshold  = 1;
-
-  // Transverse and longitudinal diffusion coefficients (Xe/Isobutane)
-  if (!(fDiffusionT))    fDiffusionT    = 0.060;
-  if (!(fDiffusionL))    fDiffusionL    = 0.017;
-
-  // The default parameter for the clustering
-  if (!(fClusMaxThresh)) fClusMaxThresh = 5.0;
-  if (!(fClusSigThresh)) fClusSigThresh = 2.0;
-  if (!(fClusMethod))    fClusMethod    = 1;
-
-  for (Int_t i = 0; i < 80; i++) printf("*");
-  printf("\n");
+  Float_t poti        = TMath::Log(kPoti);
+  Float_t eEnd        = TMath::Log(kEend);
 
-}
-
-//_____________________________________________________________________________
-Float_t AliTRDv1::PadResponse(Float_t x)
-{
-  //
-  // The pad response for the chevron pads. 
-  // We use a simple Gaussian approximation which should be good
-  // enough for our purpose.
-  //
-
-  // The parameters for the response function
-  const Float_t aa  =  0.8872;
-  const Float_t bb  = -0.00573;
-  const Float_t cc  =  0.454;
-  const Float_t cc2 =  cc*cc;
+  // Ermilova distribution for the delta-ray spectrum
+  fDeltaE = new TF1("deltae" ,Ermilova ,poti,eEnd,0);
 
-  Float_t pr = aa * (bb + TMath::Exp(-x*x / (2. * cc2)));
+  // Geant3 distribution for the delta-ray spectrum
+  fDeltaG = new TF1("deltag",IntSpecGeant,2.421257,28.536469,0);
 
-  return (pr);
+  AliDebug(1,"+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++");
 
 }
 
 //_____________________________________________________________________________
-void AliTRDv1::SetSensPlane(Int_t iplane)
+void AliTRDv1::StepManager()
 {
   //
-  // Defines the hit-sensitive plane (1-6)
+  // Slow simulator. Every charged track produces electron cluster as hits
+  // along its path across the drift volume. 
   //
 
-  if ((iplane < 0) || (iplane > 6)) {
-    printf("Wrong input value: %d\n",iplane);
-    printf("Use standard setting\n");
-    fSensPlane  = 0;
-    fSensSelect = 0;
-    return;
+  switch (fTypeOfStepManager) {
+   case 0: 
+    StepManagerErmilova();
+    break;  
+   case 1: 
+    StepManagerGeant();  
+    break;  
+   case 2: 
+    StepManagerFixedStep();
+    break;  
+   default: 
+    AliWarning("Not a valid Step Manager.");
   }
 
-  fSensSelect = 1;
-  fSensPlane  = iplane;
-
 }
 
 //_____________________________________________________________________________
-void AliTRDv1::SetSensChamber(Int_t ichamber)
+void AliTRDv1::SelectStepManager(Int_t t)
 {
   //
-  // Defines the hit-sensitive chamber (1-5)
+  // Selects a step manager type:
+  //   0 - Ermilova
+  //   1 - Geant3
+  //   2 - Fixed step size
   //
 
-  if ((ichamber < 0) || (ichamber > 5)) {
-    printf("Wrong input value: %d\n",ichamber);
-    printf("Use standard setting\n");
-    fSensChamber = 0;
-    fSensSelect  = 0;
-    return;
-  }
-
-  fSensSelect  = 1;
-  fSensChamber = ichamber;
+  fTypeOfStepManager = t;
+  AliInfo(Form("Step Manager type %d was selected",fTypeOfStepManager));
 
 }
 
 //_____________________________________________________________________________
-void AliTRDv1::SetSensSector(Int_t isector)
+void AliTRDv1::StepManagerGeant()
 {
   //
-  // Defines the hit-sensitive sector (1-18)
+  // Slow simulator. Every charged track produces electron cluster as hits
+  // along its path across the drift volume. The step size is set acording
+  // to Bethe-Bloch. The energy distribution of the delta electrons follows
+  // a spectrum taken from Geant3.
+  //
+  // Works only for Xe/CO2!!
+  //
+  // Version by A. Bercuci
   //
 
-  if ((isector < 0) || (isector > 18)) {
-    printf("Wrong input value: %d\n",isector);
-    printf("Use standard setting\n");
-    fSensSector = 0;
-    fSensSelect = 0;
-    return;
-  }
+  Int_t    layer  = 0;
+  Int_t    stack  = 0;
+  Int_t    sector = 0;
+  Int_t    det    = 0;
+  Int_t    iPdg;
+  Int_t    qTot;
+
+  Float_t  hits[3];
+  Float_t  charge;
+  Float_t  aMass;
+
+  Double_t pTot     = 0;
+  Double_t eDelta;
+  Double_t betaGamma;
+  Double_t pp;
+  Double_t stepSize = 0;
+
+  Bool_t   drRegion = kFALSE;
+  Bool_t   amRegion = kFALSE;
+
+  TString  cIdPath;
+  Char_t   cIdSector[3];
+           cIdSector[2]  = 0;
+
+  TString  cIdCurrent;
+  TString  cIdSensDr = "J";
+  TString  cIdSensAm = "K";
+  Char_t   cIdChamber[3];
+           cIdChamber[2] = 0;
+
+  TLorentzVector pos;
+  TLorentzVector mom;
+
+  TArrayI        processes;
+
+  const Int_t    kNlayer      = AliTRDgeometry::Nlayer();
+  const Int_t    kNstack      = AliTRDgeometry::Nstack();
+  const Int_t    kNdetsec     = kNlayer * kNstack;
+
+  const Double_t kBig         = 1.0e+12; // Infinitely big
+  const Float_t  kPTotMaxEl   = 0.002;   // Maximum momentum for e+ e- g
+
+  // Minimum energy for the step size adjustment
+  const Float_t  kEkinMinStep = 1.0e-5;
+  // energy threshold for production of delta electrons
+  const Float_t  kECut        = 1.0e4;
+  // Parameters entering the parametrized range for delta electrons
+  const Float_t  kRa          = 5.37e-4;
+  const Float_t  kRb          = 0.9815;
+  const Float_t  kRc          = 3.123e-3;
+  // Gas density -> To be made user adjustable !
+  // [0.85*0.00549+0.15*0.00186 (Xe-CO2 85-15)]
+  const Float_t  kRho         = 0.004945 ; 
+
+  // Plateau value of the energy-loss for electron in xenon
+  // The averaged value (26/3/99)
+  const Float_t  kPlateau     = 1.55;
+  // dN1/dx|min for the gas mixture (90% Xe + 10% CO2)
+  const Float_t  kPrim        = 19.34;  
+  // First ionization potential (eV) for the gas mixture (90% Xe + 10% CO2)
+  const Float_t  kPoti        = 12.1;
+  // PDG code electron
+  const Int_t    kPdgElectron = 11;  
+
+  // Set the maximum step size to a very large number for all
+  // neutral particles and those outside the driftvolume
+  gMC->SetMaxStep(kBig);
+
+  // Use only charged tracks
+  if (( gMC->TrackCharge()       ) &&
+      (!gMC->IsTrackDisappeared())) {
+
+    // Inside a sensitive volume?
+    drRegion = kFALSE;
+    amRegion = kFALSE;
+    cIdCurrent = gMC->CurrentVolName();
+    if (cIdSensDr == cIdCurrent[1]) {
+      drRegion = kTRUE;
+    }
+    if (cIdSensAm == cIdCurrent[1]) {
+      amRegion = kTRUE;
+    }
+    if (drRegion || amRegion) {
+
+      // The hit coordinates and charge
+      gMC->TrackPosition(pos);
+      hits[0] = pos[0];
+      hits[1] = pos[1];
+      hits[2] = pos[2];
+
+      // The sector number (0 - 17), according to standard coordinate system
+      cIdPath      = gGeoManager->GetPath();
+      cIdSector[0] = cIdPath[21];
+      cIdSector[1] = cIdPath[22];
+      sector = atoi(cIdSector);
+
+      // The layer and stack number
+      cIdChamber[0]   = cIdCurrent[2];
+      cIdChamber[1]   = cIdCurrent[3];
+      Int_t idChamber = (atoi(cIdChamber) % kNdetsec);
+      stack = ((Int_t) idChamber / kNlayer);
+      layer = ((Int_t) idChamber % kNlayer);
+
+      // The detector number
+      det = fGeometry->GetDetector(layer,stack,sector);
+
+      // Special hits only in the drift region
+      if      ((drRegion) &&
+               (gMC->IsTrackEntering())) {
+
+        // Create a track reference at the entrance of each
+        // chamber that contains the momentum components of the particle
+        gMC->TrackMomentum(mom);
+        AddTrackReference(gAlice->GetMCApp()->GetCurrentTrackNumber(), AliTrackReference::kTRD);
+
+        // Create the hits from TR photons if electron/positron is
+        // entering the drift volume
+        if ((fTR) && 
+            (TMath::Abs(gMC->TrackPid()) == kPdgElectron)) {
+          CreateTRhit(det);
+        }
 
-  fSensSelect = 1;
-  fSensSector = isector;
+      }
+      else if ((amRegion) && 
+               (gMC->IsTrackExiting())) {
+
+        // Create a track reference at the exit of each
+        // chamber that contains the momentum components of the particle
+        gMC->TrackMomentum(mom);
+        AddTrackReference(gAlice->GetMCApp()->GetCurrentTrackNumber(), AliTrackReference::kTRD);
+
+      }
+
+      // Calculate the energy of the delta-electrons
+      // modified by Alex Bercuci (A.Bercuci@gsi.de) on 26.01.06
+      // take into account correlation with the underlying GEANT tracking
+      // mechanism. see
+      // http://www-linux.gsi.de/~abercuci/Contributions/TRD/index.html
+      //
+      // determine the most significant process (last on the processes list)
+      // which caused this hit
+      gMC->StepProcesses(processes);
+      Int_t nofprocesses = processes.GetSize();
+      Int_t pid;
+      if (!nofprocesses) {
+        pid = 0;
+      }
+      else {
+        pid = processes[nofprocesses-1];               
+      }                
+               
+      // Generate Edep according to GEANT parametrisation
+      eDelta = TMath::Exp(fDeltaG->GetRandom()) - kPoti;
+      eDelta = TMath::Max(eDelta,0.0);
+      Float_t prRange = 0.0;
+      Float_t range   = gMC->TrackLength() - fTrackLength0;
+      // merge GEANT tracker information with locally cooked one
+      if (gAlice->GetMCApp()->GetCurrentTrackNumber() == fPrimaryTrackPid) {
+       if      (pid == 27) { 
+          if (eDelta >= kECut) {                
+            prRange = kRa * eDelta * 0.001
+                    * (1.0 - kRb / (1.0 + kRc * eDelta * 0.001)) / kRho;
+            if (prRange >= (3.7 - range)) {
+              eDelta *= 0.1;
+            }
+          }
+        } 
+        else if (pid ==  1) {  
+          if (eDelta <  kECut) {
+            eDelta *= 0.5;
+          }
+          else {                
+            prRange = kRa * eDelta * 0.001
+                    * (1.0 - kRb / (1.0 + kRc * eDelta * 0.001)) / kRho;
+            if (prRange >= ((AliTRDgeometry::DrThick()
+                           + AliTRDgeometry::AmThick()) - range)) {
+              eDelta *= 0.05;
+            }
+            else {
+              eDelta *= 0.5;
+            }
+          }
+        } 
+        else {
+          eDelta = 0.0;
+        }      
+      } 
+      else {
+        eDelta = 0.0;
+      }
+
+      // Generate the electron cluster size
+      if (eDelta > 0.0) {
+
+        qTot = ((Int_t) (eDelta / fWion) + 1);
+
+        // Create a new dEdx hit
+        AddHit(gAlice->GetMCApp()->GetCurrentTrackNumber()
+              ,det
+              ,hits
+              ,qTot
+              ,gMC->TrackTime()*1.0e06
+              ,drRegion);
+
+      }
+                       
+      // Calculate the maximum step size for the next tracking step
+      // Produce only one hit if Ekin is below cutoff
+      aMass = gMC->TrackMass();
+      if ((gMC->Etot() - aMass) > kEkinMinStep) {
+
+        // The energy loss according to Bethe Bloch
+        iPdg = TMath::Abs(gMC->TrackPid());
+        if ((iPdg != kPdgElectron) ||
+           ((iPdg == kPdgElectron) && 
+             (pTot  < kPTotMaxEl))) {
+          gMC->TrackMomentum(mom);
+          pTot      = mom.Rho();
+          betaGamma = pTot / aMass;
+          pp        = BetheBlochGeant(betaGamma);
+         // Take charge > 1 into account
+          charge     = gMC->TrackCharge();
+          if (TMath::Abs(charge) > 1) {
+            pp = pp * charge*charge;
+          }
+        } 
+        else { 
+          // Electrons above 20 Mev/c are at the plateau
+          pp = kPrim * kPlateau;
+        }
+
+       Int_t nsteps = 0;
+        do {
+          nsteps = gRandom->Poisson(pp);
+        } while(!nsteps);
+        stepSize = 1.0 / nsteps;
+        gMC->SetMaxStep(stepSize);
+
+      }
+
+    }
+
+  }
 
 }
 
 //_____________________________________________________________________________
-void AliTRDv1::StepManager()
+void AliTRDv1::StepManagerErmilova()
 {
   //
-  // Called at every step in the Transition Radiation Detector version 2.
   // Slow simulator. Every charged track produces electron cluster as hits 
   // along its path across the drift volume. The step size is set acording
   // to Bethe-Bloch. The energy distribution of the delta electrons follows
   // a spectrum taken from Ermilova et al.
   //
+  // Works only for Xe/CO2!!
+  //
 
-  Int_t    iIdSens, icSens;
-  Int_t    iIdSpace, icSpace;
-  Int_t    iIdChamber, icChamber;
-  Int_t    vol[3]; 
-  Int_t    iPid;
+  Int_t    layer  = 0;
+  Int_t    stack  = 0;
+  Int_t    sector = 0;
+  Int_t    det    = 0;
+  Int_t    iPdg;
+  Int_t    qTot;
 
-  Float_t  hits[4];
-  Float_t  random[1];
+  Float_t  hits[3];
+  Double_t random[1];
   Float_t  charge;
   Float_t  aMass;
 
-  Double_t pTot;
-  Double_t qTot;
+  Double_t pTot     = 0.0;
   Double_t eDelta;
-  Double_t betaGamma, pp;
+  Double_t betaGamma;
+  Double_t pp;
+  Double_t stepSize;
+
+  Bool_t   drRegion = kFALSE;
+  Bool_t   amRegion = kFALSE;
+
+  TString  cIdPath;
+  Char_t   cIdSector[3];
+           cIdSector[2]  = 0;
+
+  TString  cIdCurrent;
+  TString  cIdSensDr = "J";
+  TString  cIdSensAm = "K";
+  Char_t   cIdChamber[3];
+           cIdChamber[2] = 0;
 
-  TLorentzVector pos, mom;
-  TClonesArray  &lhits = *fHits;
+  TLorentzVector pos;
+  TLorentzVector mom;
 
-  const Double_t kBig = 1.0E+12;
+  const Int_t    kNlayer      = AliTRDgeometry::Nlayer();
+  const Int_t    kNstack      = AliTRDgeometry::Nstack();
+  const Int_t    kNdetsec     = kNlayer * kNstack;
+
+  const Double_t kBig         = 1.0e+12; // Infinitely big
+  const Float_t  kPTotMaxEl   = 0.002;   // Maximum momentum for e+ e- g 
+
+  // Minimum energy for the step size adjustment
+  const Float_t  kEkinMinStep = 1.0e-5;
 
-  // Ionization energy
-  const Float_t kWion    = 22.04;
-  // Maximum energy for e+ e- g for the step-size calculation
-  const Float_t kPTotMax = 0.002;
   // Plateau value of the energy-loss for electron in xenon
-  // taken from: Allison + Comb, Ann. Rev. Nucl. Sci. (1980), 30, 253
-  //const Double_t kPlateau = 1.70;
-  // the averaged value (26/3/99)
-  const Float_t kPlateau = 1.55;
+  // The averaged value (26/3/99)
+  const Float_t  kPlateau     = 1.55;
   // dN1/dx|min for the gas mixture (90% Xe + 10% CO2)
-  const Float_t kPrim    = 48.0;
+  const Float_t  kPrim        = 48.0;  
   // First ionization potential (eV) for the gas mixture (90% Xe + 10% CO2)
-  const Float_t kPoti    = 12.1;
+  const Float_t  kPoti        = 12.1;
+  // PDG code electron
+  const Int_t    kPdgElectron = 11;  
 
   // Set the maximum step size to a very large number for all 
   // neutral particles and those outside the driftvolume
@@ -842,94 +780,134 @@ void AliTRDv1::StepManager()
 
   // Use only charged tracks 
   if (( gMC->TrackCharge()       ) &&
-      (!gMC->IsTrackStop()       ) && 
       (!gMC->IsTrackDisappeared())) {
 
     // Inside a sensitive volume?
-    iIdSens = gMC->CurrentVolID(icSens);
-    if (iIdSens == fIdSens) { 
-
-      iIdSpace   = gMC->CurrentVolOffID(4,icSpace  );
-      iIdChamber = gMC->CurrentVolOffID(1,icChamber);
-
-      // Calculate the energy of the delta-electrons
-      eDelta = TMath::Exp(fDeltaE->GetRandom()) - kPoti;
-      eDelta = TMath::Max(eDelta,0.0);
-
-      // The number of secondary electrons created
-      qTot = (Double_t) ((Int_t) (eDelta / kWion) + 1);
+    drRegion = kFALSE;
+    amRegion = kFALSE;
+    cIdCurrent = gMC->CurrentVolName();
+    if (cIdSensDr == cIdCurrent[1]) {
+      drRegion = kTRUE;
+    }
+    if (cIdSensAm == cIdCurrent[1]) {
+      amRegion = kTRUE;
+    }
+    if (drRegion || amRegion) {
 
       // The hit coordinates and charge
       gMC->TrackPosition(pos);
       hits[0] = pos[0];
       hits[1] = pos[1];
       hits[2] = pos[2];
-      hits[3] = qTot;
-
-      // The sector number
-      Float_t phi = pos[1] != 0 ? TMath::Atan2(pos[0],pos[1]) : (pos[0] > 0 ? 180. : 0.);
-      vol[0] = ((Int_t) (phi / 20)) + 1;
-
-      // The chamber number 
-      //   1: outer left
-      //   2: middle left
-      //   3: inner
-      //   4: middle right
-      //   5: outer right
-      if      (iIdChamber == fIdChamber1)
-        vol[1] = (hits[2] < 0 ? 1 : 5);
-      else if (iIdChamber == fIdChamber2)       
-        vol[1] = (hits[2] < 0 ? 2 : 4);
-      else if (iIdChamber == fIdChamber3)       
-        vol[1] = 3;
-
-      // The plane number
-      vol[2] = icChamber - TMath::Nint((Float_t) (icChamber / 7)) * 6;
-
-      // Check on selected volumes
-      Int_t addthishit = 1;
-      if (fSensSelect) {
-        if ((fSensPlane)   && (vol[2] != fSensPlane  )) addthishit = 0;
-        if ((fSensChamber) && (vol[1] != fSensChamber)) addthishit = 0;
-        if ((fSensSector)  && (vol[0] != fSensSector )) addthishit = 0;
+
+      // The sector number (0 - 17), according to standard coordinate system
+      cIdPath      = gGeoManager->GetPath();
+      cIdSector[0] = cIdPath[21];
+      cIdSector[1] = cIdPath[22];
+      sector = atoi(cIdSector);
+
+      // The plane and chamber number
+      cIdChamber[0] = cIdCurrent[2];
+      cIdChamber[1] = cIdCurrent[3];
+      Int_t idChamber = (atoi(cIdChamber) % kNdetsec);
+      stack = ((Int_t) idChamber / kNlayer);
+      layer = ((Int_t) idChamber % kNlayer);
+
+      // The detector number
+      det = fGeometry->GetDetector(layer,stack,sector);
+
+      // Special hits only in the drift region
+      if      ((drRegion) &&
+               (gMC->IsTrackEntering())) {
+
+        // Create a track reference at the entrance of each
+        // chamber that contains the momentum components of the particle
+        gMC->TrackMomentum(mom);
+        AddTrackReference(gAlice->GetMCApp()->GetCurrentTrackNumber(), AliTrackReference::kTRD);
+
+        // Create the hits from TR photons if electron/positron is
+        // entering the drift volume
+        if ((fTR) && 
+            (TMath::Abs(gMC->TrackPid()) == kPdgElectron)) {
+          CreateTRhit(det);
+        }
+
       }
+      else if ((amRegion) && 
+               (gMC->IsTrackExiting())) {
 
-      // Add this hit
-      if (addthishit) {
+        // Create a track reference at the exit of each
+        // chamber that contains the momentum components of the particle
+        gMC->TrackMomentum(mom);
+        AddTrackReference(gAlice->GetMCApp()->GetCurrentTrackNumber(), AliTrackReference::kTRD);
 
-        new(lhits[fNhits++]) AliTRDhit(fIshunt,gAlice->CurrentTrack(),vol,hits);
+      }
+
+      // Calculate the energy of the delta-electrons
+      eDelta = TMath::Exp(fDeltaE->GetRandom()) - kPoti;
+      eDelta = TMath::Max(eDelta,0.0);
+
+      // Generate the electron cluster size
+      if (eDelta > 0.0) {
+
+        qTot = ((Int_t) (eDelta / fWion) + 1);
+
+       // Create a new dEdx hit
+        if (drRegion) {
+          AddHit(gAlice->GetMCApp()->GetCurrentTrackNumber()
+                ,det
+                ,hits
+                ,qTot
+                ,gMC->TrackTime()*1.0e06
+                ,kTRUE);
+       }
+        else {
+          AddHit(gAlice->GetMCApp()->GetCurrentTrackNumber()
+                ,det
+                ,hits
+                ,qTot
+                ,gMC->TrackTime()*1.0e06
+                ,kFALSE);
+       }
+
+      }
+
+      // Calculate the maximum step size for the next tracking step
+      // Produce only one hit if Ekin is below cutoff 
+      aMass = gMC->TrackMass();
+      if ((gMC->Etot() - aMass) > kEkinMinStep) {
 
         // The energy loss according to Bethe Bloch
-        gMC->TrackMomentum(mom);
-        pTot = mom.Rho();
-        iPid = gMC->TrackPid();
-        if ( (iPid >  3) ||
-           ((iPid <= 3) && (pTot < kPTotMax))) {
-          aMass     = gMC->TrackMass();
+        iPdg  = TMath::Abs(gMC->TrackPid());
+        if ((iPdg != kPdgElectron) ||
+           ((iPdg == kPdgElectron) && 
+             (pTot  < kPTotMaxEl))) {
+          gMC->TrackMomentum(mom);
+          pTot      = mom.Rho();
           betaGamma = pTot / aMass;
           pp        = kPrim * BetheBloch(betaGamma);
-         // Take charge > 1 into account
+          // Take charge > 1 into account
           charge = gMC->TrackCharge();
-          if (TMath::Abs(charge) > 1) pp = pp * charge*charge;
-        }
-        // Electrons above 20 Mev/c are at the plateau
-        else {
-          pp = kPrim * kPlateau;
+          if (TMath::Abs(charge) > 1) {
+            pp = pp * charge*charge;
+          }
+        } 
+        else { 
+          // Electrons above 20 Mev/c are at the plateau
+         pp = kPrim * kPlateau;
         }
       
-        // Calculate the maximum step size for the next tracking step
-        if (pp > 0) {
-          do 
-            gMC->Rndm(random,1);
-          while ((random[0] == 1.) || (random[0] == 0.));
-          gMC->SetMaxStep( - TMath::Log(random[0]) / pp);
-       }
+        if (pp > 0.0) {
+          do {
+            gMC->GetRandom()->RndmArray(1,random);
+         }
+          while ((random[0] == 1.0) || 
+                 (random[0] == 0.0));
+          stepSize = - TMath::Log(random[0]) / pp; 
+          gMC->SetMaxStep(stepSize);
+        }
 
       }
-      else {
-        // set step size to maximal value
-        gMC->SetMaxStep(kBig); 
-      }
 
     }
 
@@ -937,6 +915,154 @@ void AliTRDv1::StepManager()
 
 }
 
+//_____________________________________________________________________________
+void AliTRDv1::StepManagerFixedStep()
+{
+  //
+  // Slow simulator. Every charged track produces electron cluster as hits 
+  // along its path across the drift volume. The step size is fixed in
+  // this version of the step manager.
+  //
+  // Works for Xe/CO2 as well as Ar/CO2
+  //
+
+  // PDG code electron
+  const Int_t   kPdgElectron = 11;
+
+  Int_t    layer  = 0;
+  Int_t    stack  = 0;
+  Int_t    sector = 0;
+  Int_t    det    = 0;
+  Int_t    qTot;
+
+  Float_t  hits[3];
+  Double_t eDep;
+
+  Bool_t   drRegion = kFALSE;
+  Bool_t   amRegion = kFALSE;
+
+  TString  cIdPath;
+  Char_t   cIdSector[3];
+           cIdSector[2]  = 0;
+
+  TString  cIdCurrent;
+  TString  cIdSensDr = "J";
+  TString  cIdSensAm = "K";
+  Char_t   cIdChamber[3];
+           cIdChamber[2] = 0;
+
+  TLorentzVector pos;
+  TLorentzVector mom;
+
+  const Int_t    kNlayer      = AliTRDgeometry::Nlayer();
+  const Int_t    kNstack      = AliTRDgeometry::Nstack();
+  const Int_t    kNdetsec     = kNlayer * kNstack;
+
+  const Double_t kBig         = 1.0e+12;
+  const Float_t  kEkinMinStep = 1.0e-5;  // Minimum energy for the step size adjustment
+
+  // Set the maximum step size to a very large number for all 
+  // neutral particles and those outside the driftvolume
+  gMC->SetMaxStep(kBig); 
+
+  // If not charged track or already stopped or disappeared, just return.
+  if ((!gMC->TrackCharge()) || 
+        gMC->IsTrackDisappeared()) {
+    return;
+  }
+
+  // Inside a sensitive volume?
+  cIdCurrent = gMC->CurrentVolName();
+
+  if (cIdSensDr == cIdCurrent[1]) {
+    drRegion = kTRUE;
+  }
+  if (cIdSensAm == cIdCurrent[1]) {
+    amRegion = kTRUE;
+  }
+
+  if ((!drRegion) && 
+      (!amRegion)) {
+    return;
+  }
+
+  // The hit coordinates and charge
+  gMC->TrackPosition(pos);
+  hits[0] = pos[0];
+  hits[1] = pos[1];
+  hits[2] = pos[2];
+
+  // The sector number (0 - 17), according to standard coordinate system
+  cIdPath      = gGeoManager->GetPath();
+  cIdSector[0] = cIdPath[21];
+  cIdSector[1] = cIdPath[22];
+  sector = atoi(cIdSector);
+
+  // The plane and chamber number
+  cIdChamber[0]   = cIdCurrent[2];
+  cIdChamber[1]   = cIdCurrent[3];
+  Int_t idChamber = (atoi(cIdChamber) % kNdetsec);
+  stack = ((Int_t) idChamber / kNlayer);
+  layer = ((Int_t) idChamber % kNlayer);
+
+  // The detector number
+  det = fGeometry->GetDetector(layer,stack,sector);
+
+  // 0: InFlight 1:Entering 2:Exiting
+  Int_t trkStat = 0;
+
+  // Special hits only in the drift region
+  if      ((drRegion) &&
+           (gMC->IsTrackEntering())) {
+
+    // Create a track reference at the entrance of each
+    // chamber that contains the momentum components of the particle
+    gMC->TrackMomentum(mom);
+    AddTrackReference(gAlice->GetMCApp()->GetCurrentTrackNumber(), AliTrackReference::kTRD);
+    trkStat = 1;
+
+    // Create the hits from TR photons if electron/positron is
+    // entering the drift volume
+    if ((fTR) && 
+        (TMath::Abs(gMC->TrackPid()) == kPdgElectron)) {
+      CreateTRhit(det);
+    }
+
+  }
+  else if ((amRegion) && 
+           (gMC->IsTrackExiting())) {
+
+    // Create a track reference at the exit of each
+    // chamber that contains the momentum components of the particle
+    gMC->TrackMomentum(mom);
+    AddTrackReference(gAlice->GetMCApp()->GetCurrentTrackNumber(), AliTrackReference::kTRD);
+    trkStat = 2;
+
+  }
+  
+  // Calculate the charge according to GEANT Edep
+  // Create a new dEdx hit
+  eDep = TMath::Max(gMC->Edep(),0.0) * 1.0e+09;
+  qTot = (Int_t) (eDep / fWion);
+  if ((qTot) ||
+      (trkStat)) {
+    AddHit(gAlice->GetMCApp()->GetCurrentTrackNumber()
+          ,det
+          ,hits
+          ,qTot
+          ,gMC->TrackTime()*1.0e06
+          ,drRegion);
+  }
+
+  // Set Maximum Step Size
+  // Produce only one hit if Ekin is below cutoff
+  if ((gMC->Etot() - gMC->TrackMass()) < kEkinMinStep) {
+    return;
+  }
+  gMC->SetMaxStep(fStepSize);
+
+}
+
 //_____________________________________________________________________________
 Double_t AliTRDv1::BetheBloch(Double_t bg) 
 {
@@ -946,29 +1072,71 @@ Double_t AliTRDv1::BetheBloch(Double_t bg)
   //
 
   // This parameters have been adjusted to averaged values from GEANT
-  const Double_t kP1 = 7.17960e-02;
-  const Double_t kP2 = 8.54196;
-  const Double_t kP3 = 1.38065e-06;
-  const Double_t kP4 = 5.30972;
-  const Double_t kP5 = 2.83798;
-
-  // This parameters have been adjusted to Xe-data found in:
-  // Allison & Cobb, Ann. Rev. Nucl. Sci. (1980), 30, 253
-  //const Double_t kP1 = 0.76176E-1;
-  //const Double_t kP2 = 10.632;
-  //const Double_t kP3 = 3.17983E-6;
-  //const Double_t kP4 = 1.8631;
-  //const Double_t kP5 = 1.9479;
-
-  if (bg > 0) {
-    Double_t yy = bg / TMath::Sqrt(1. + bg*bg);
+  const Double_t kP1    = 7.17960e-02;
+  const Double_t kP2    = 8.54196;
+  const Double_t kP3    = 1.38065e-06;
+  const Double_t kP4    = 5.30972;
+  const Double_t kP5    = 2.83798;
+
+  // Lower cutoff of the Bethe-Bloch-curve to limit step sizes
+  const Double_t kBgMin = 0.8;
+  const Double_t kBBMax = 6.83298;
+
+  if (bg > kBgMin) {
+    Double_t yy = bg / TMath::Sqrt(1.0 + bg*bg);
     Double_t aa = TMath::Power(yy,kP4);
-    Double_t bb = TMath::Power((1./bg),kP5);
+    Double_t bb = TMath::Power((1.0/bg),kP5);
              bb = TMath::Log(kP3 + bb);
-    return ((kP2 - aa - bb)*kP1 / aa);
+    return ((kP2 - aa - bb) * kP1 / aa);
   }
-  else
-    return 0;
+  else {
+    return kBBMax;
+  }
+
+}
+
+//_____________________________________________________________________________
+Double_t AliTRDv1::BetheBlochGeant(Double_t bg)
+{
+  //
+  // Return dN/dx (number of primary collisions per centimeter)
+  // for given beta*gamma factor.
+  //
+  // Implemented by K.Oyama according to GEANT 3 parametrization shown in
+  // A.Andronic's webpage: http://www-alice.gsi.de/trd/papers/dedx/dedx.html
+  // This must be used as a set with IntSpecGeant.
+  //
+
+  Int_t    i = 0;
+
+  Double_t arrG[20]  = {     1.100000,     1.200000,     1.300000,     1.500000
+                       ,     1.800000,     2.000000,     2.500000,     3.000000
+                       ,     4.000000,     7.000000,    10.000000,    20.000000
+                       ,    40.000000,    70.000000,   100.000000,   300.000000
+                       ,   600.000000,  1000.000000,  3000.000000, 10000.000000 };
+
+  Double_t arrNC[20] = {    75.009056,    45.508083,    35.299252,    27.116327
+                       ,    22.734999,    21.411915,    19.934095,    19.449375
+                       ,    19.344431,    20.185553,    21.027925,    22.912676
+                       ,    24.933352,    26.504053,    27.387468,    29.566597
+                       ,    30.353779,    30.787134,    31.129285,    31.157350 };
+
+  // Betagamma to gamma
+  Double_t g = TMath::Sqrt(1.0 + bg*bg);
+
+  // Find the index just before the point we need.
+  for (i = 0; i < 18; i++) {
+    if ((arrG[i]   < g) && 
+        (arrG[i+1] > g)) {
+      break;
+    }
+  }
+
+  // Simple interpolation.
+  Double_t pp = ((arrNC[i+1] - arrNC[i]) / (arrG[i+1]  - arrG[i])) 
+              * (g - arrG[i]) + arrNC[i];
+
+  return pp;
 
 }
 
@@ -984,37 +1152,41 @@ Double_t Ermilova(Double_t *x, Double_t *)
   Double_t dpos;
   Double_t dnde;
 
-  Int_t    pos1, pos2;
+  Int_t    pos1;
+  Int_t    pos2;
 
-  const Int_t nV = 31;
+  const Int_t kNv = 31;
 
-  Float_t vxe[nV] = { 2.3026, 2.9957, 3.4012, 3.6889, 3.9120  
-                    , 4.0943, 4.2485, 4.3820, 4.4998, 4.6052
-                    , 4.7005, 5.0752, 5.2983, 5.7038, 5.9915
-                    , 6.2146, 6.5221, 6.9078, 7.3132, 7.6009
-                    , 8.0064, 8.5172, 8.6995, 8.9872, 9.2103
-                    , 9.4727, 9.9035,10.3735,10.5966,10.8198
-                    ,11.5129 };
+  Float_t vxe[kNv] = {  2.3026,  2.9957,  3.4012,  3.6889,  3.9120  
+                     ,  4.0943,  4.2485,  4.3820,  4.4998,  4.6052
+                     ,  4.7005,  5.0752,  5.2983,  5.7038,  5.9915
+                     ,  6.2146,  6.5221,  6.9078,  7.3132,  7.6009
+                     ,  8.0064,  8.5172,  8.6995,  8.9872,  9.2103
+                     ,  9.4727,  9.9035, 10.3735, 10.5966, 10.8198
+                     , 11.5129 };
 
-  Float_t vye[nV] = { 80.0  , 31.0  , 23.3  , 21.1  , 21.0
-                    , 20.9  , 20.8  , 20.0  , 16.0  , 11.0
-                    ,  8.0  ,  6.0  ,  5.2  ,  4.6  ,  4.0
-                    ,  3.5  ,  3.0  ,  1.4  ,  0.67 ,  0.44
-                    ,  0.3  ,  0.18 ,  0.12 ,  0.08 ,  0.056
-                    ,  0.04 ,  0.023,  0.015,  0.011,  0.01
-                   ,  0.004 };
+  Float_t vye[kNv] = { 80.0,    31.0,    23.3,    21.1,    21.0
+                     , 20.9,    20.8,    20.0,    16.0,    11.0
+                     ,  8.0,     6.0,     5.2,     4.6,     4.0
+                     ,  3.5,     3.0,     1.4,     0.67,    0.44
+                     ,  0.3,     0.18,    0.12,    0.08,    0.056
+                     ,  0.04,    0.023,   0.015,   0.011,    0.01
+                    ,  0.004  };
 
   energy = x[0];
 
   // Find the position 
-  pos1 = pos2 = 0;
+  pos1 = 0;
+  pos2 = 0;
   dpos = 0;
   do {
     dpos = energy - vxe[pos2++];
   } 
   while (dpos > 0);
   pos2--; 
-  if (pos2 > nV) pos2 = nV;
+  if (pos2 > kNv) {
+    pos2 = kNv - 1;
+  }
   pos1 = pos2 - 1;
 
   // Differentiate between the sampling points
@@ -1025,96 +1197,74 @@ Double_t Ermilova(Double_t *x, Double_t *)
 }
 
 //_____________________________________________________________________________
-void AliTRDv1::Pads2XYZ(Float_t *pads, Float_t *pos)
+Double_t IntSpecGeant(Double_t *x, Double_t *)
 {
-  // Method to convert pad coordinates (row,col,time)
-  // into ALICE reference frame coordinates (x,y,z)
-
-  Int_t        chamber   = (Int_t) pads[0];     // chamber info (1-5)
-  Int_t        sector    = (Int_t) pads[1];     // sector info  (1-18)
-  Int_t        plane     = (Int_t) pads[2];     // plane info   (1-6)
-
-  Int_t        icham     = chamber - 1;         // chamber info (0-4)
-  Int_t        isect     = sector  - 1;         // sector info  (0-17)
-  Int_t        iplan     = plane   - 1;         // plane info   (0-5)
-
-  Float_t      padRow    = pads[3];             // Pad Row position
-  Float_t      padCol    = pads[4];             // Pad Column position
-  Float_t      timeSlice = pads[5];             // Time "position"
-
-  // calculate (x,y) position in rotated chamber
-  Float_t yRot = fCol0[iplan]               + padCol    * fColPadSize;
-  Float_t xRot = fTime0[iplan]              + timeSlice * fTimeBinSize;
-  // calculate z-position:
-  Float_t z    = fRow0[iplan][icham][isect] + padRow    * fRowPadSize;
-
-  /**
-    rotate chamber back to original position
-    1. mirror at y-axis, 2. rotate back to position (-phi)
-    / cos(phi) -sin(phi) \   / -1 0 \     / -cos(phi) -sin(phi) \
-    \ sin(phi)  cos(phi) / * \  0 1 /  =  \ -sin(phi)  cos(phi) /
-  **/
-  //Float_t phi = 2*kPI / kNsect * ((Float_t) sector - 0.5);
-  //Float_t x = -xRot * TMath::Cos(phi) - yRot * TMath::Sin(phi);
-  //Float_t y = -xRot * TMath::Sin(phi) + yRot * TMath::Cos(phi);
-  Float_t phi = 2*kPI / kNsect * ((Float_t) sector - 0.5);
-  Float_t x   = -xRot * TMath::Cos(phi) + yRot * TMath::Sin(phi);
-  Float_t y   =  xRot * TMath::Sin(phi) + yRot * TMath::Cos(phi);
-
-  // Setting values
-  pos[0] = x;
-  pos[1] = y;
-  pos[2] = z;
-
-}
-
-//_____________________________________________________________________________
-Float_t AliTRDv1::Unfold(Float_t eps, Float_t* padSignal)
-{
-  // Method to unfold neighbouring maxima.
-  // The charge ratio on the overlapping pad is calculated
-  // until there is no more change within the range given by eps.
-  // The resulting ratio is then returned to the calling method.
-
-  Int_t   itStep            = 0;      // count iteration steps
-
-  Float_t ratio             = 0.5;    // start value for ratio
-  Float_t prevRatio         = 0;      // store previous ratio
-
-  Float_t newLeftSignal[3]  = {0};    // array to store left cluster signal
-  Float_t newRightSignal[3] = {0};    // array to store right cluster signal
-
-  // start iteration:
-  while ((TMath::Abs(prevRatio - ratio) > eps) && (itStep < 10)) {
-
-    itStep++;
-    prevRatio = ratio;
-
-    // cluster position according to charge ratio
-    Float_t maxLeft  = (ratio*padSignal[2] - padSignal[0]) /
-                       (padSignal[0] + padSignal[1] + ratio*padSignal[2]);
-    Float_t maxRight = (padSignal[4] - (1-ratio)*padSignal[2]) /
-                       ((1-ratio)*padSignal[2] + padSignal[3] + padSignal[4]);
-
-    // set cluster charge ratio
-    Float_t ampLeft  = padSignal[1];
-    Float_t ampRight = padSignal[3];
-
-    // apply pad response to parameters
-    newLeftSignal[0] = ampLeft*PadResponse(-1 - maxLeft);
-    newLeftSignal[1] = ampLeft*PadResponse( 0 - maxLeft);
-    newLeftSignal[2] = ampLeft*PadResponse( 1 - maxLeft);
+  //
+  // Integrated spectrum from Geant3
+  //
 
-    newRightSignal[0] = ampRight*PadResponse(-1 - maxRight);
-    newRightSignal[1] = ampRight*PadResponse( 0 - maxRight);
-    newRightSignal[2] = ampRight*PadResponse( 1 - maxRight);
+  const Int_t npts = 83;
+  Double_t arre[npts]    = {  2.421257,     2.483278,    2.534301,     2.592230
+                           ,  2.672067,     2.813299,    3.015059,     3.216819
+                           ,  3.418579,     3.620338,    3.868209,     3.920198
+                           ,  3.978284,     4.063923,    4.186264,     4.308605
+                           ,  4.430946,     4.553288,    4.724261,     4.837736
+                           ,  4.999842,     5.161949,    5.324056,     5.486163
+                           ,  5.679688,     5.752998,    5.857728,     5.962457
+                           ,  6.067185,     6.171914,    6.315653,     6.393674
+                           ,  6.471694,     6.539689,    6.597658,     6.655627
+                           ,  6.710957,     6.763648,    6.816338,     6.876198
+                           ,  6.943227,     7.010257,    7.106285,     7.252151
+                           ,  7.460531,     7.668911,    7.877290,     8.085670
+                           ,  8.302979,     8.353585,    8.413120,     8.483500
+                           ,  8.541030,     8.592857,    8.668865,     8.820485
+                           ,  9.037086,     9.253686,    9.470286,     9.686887
+                           ,  9.930838,     9.994655,   10.085822,    10.176990
+                           , 10.268158,    10.359325,   10.503614,    10.627565
+                           , 10.804637,    10.981709,   11.158781,    11.335854
+                           , 11.593397,    11.781165,   12.049404,    12.317644
+                           , 12.585884,    12.854123,   14.278421,    16.975889
+                           , 20.829416,    24.682943,   28.536469 };
+
+  Double_t arrdnde[npts] = { 10.960000,    10.960000,   10.359500,     9.811340
+                           ,  9.1601500,    8.206670,    6.919630,     5.655430
+                           ,  4.6221300,    3.777610,    3.019560,     2.591950
+                           ,  2.5414600,    2.712920,    3.327460,     4.928240
+                           ,  7.6185300,   10.966700,   12.225800,     8.094750
+                           ,  3.3586900,    1.553650,    1.209600,     1.263840
+                           ,  1.3241100,    1.312140,    1.255130,     1.165770
+                           ,  1.0594500,    0.945450,    0.813231,     0.699837
+                           ,  0.6235580,    2.260990,    2.968350,     2.240320
+                           ,  1.7988300,    1.553300,    1.432070,     1.535520
+                           ,  1.4429900,    1.247990,    1.050750,     0.829549
+                           ,  0.5900280,    0.395897,    0.268741,     0.185320
+                           ,  0.1292120,    0.103545,    0.0949525,    0.101535
+                           ,  0.1276380,    0.134216,    0.123816,     0.104557
+                           ,  0.0751843,    0.0521745,   0.0373546,    0.0275391
+                           ,  0.0204713,    0.0169234,   0.0154552,    0.0139194
+                           ,  0.0125592,    0.0113638,   0.0107354,    0.0102137
+                           ,  0.00845984,   0.00683338,  0.00556836,   0.00456874
+                           ,  0.0036227,    0.00285991,  0.00226664,   0.00172234
+                           ,  0.00131226,   0.00100284,  0.000465492,  7.26607e-05
+                           ,  3.63304e-06,  0.0000000,   0.0000000   };
+
+  Int_t    i;
+  Double_t energy = x[0];
+
+  if (energy >= arre[npts-1]) {
+    return 0.0;
+  }
 
-    // calculate new overlapping ratio
-    ratio = newLeftSignal[2]/(newLeftSignal[2] + newRightSignal[0]);
+  for (i = 0; i < npts; i++) {
+    if (energy < arre[i]) {
+      break;
+    }
+  }
 
+  if (i == 0) {
+    AliErrorGeneral("AliTRDv1::IntSpecGeant","Given energy value is too small or zero");
   }
 
-  return ratio;
+  return arrdnde[i];
 
 }
-