]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TRD/AliTRD.cxx
- Return from Gstpar if material is not used.
[u/mrichter/AliRoot.git] / TRD / AliTRD.cxx
index 527172204f3907bdecc364c5ba578ff724bfb5f2..010580e774cad858d64d36d3066812a6bea4b74f 100644 (file)
@@ -1,28 +1,59 @@
+/**************************************************************************
+ * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ *                                                                        *
+ * Author: The ALICE Off-line Project.                                    *
+ * Contributors are mentioned in the code where appropriate.              *
+ *                                                                        *
+ * Permission to use, copy, modify and distribute this software and its   *
+ * documentation strictly for non-commercial purposes is hereby granted   *
+ * without fee, provided that the above copyright notice appears in all   *
+ * copies and that both the copyright notice and this permission notice   *
+ * appear in the supporting documentation. The authors make no claims     *
+ * about the suitability of this software for any purpose. It is          *
+ * provided "as is" without express or implied warranty.                  *
+ **************************************************************************/
+
+/* $Id$ */
+
 ///////////////////////////////////////////////////////////////////////////////
 //                                                                           //
 //  Transition Radiation Detector                                            //
 //  This class contains the basic functions for the Transition Radiation     //
-//  detector. Functions specific to one particular geometry are              //
-//  contained in the derived classes                                         //
-//                                                                           //
-//Begin_Html
-/*
-<img src="picts/AliTRDClass.gif">
-*/
-//End_Html
-//                                                                           //
+//  Detector.                                                                //
 //                                                                           //
 ///////////////////////////////////////////////////////////////////////////////
 
+#include <stdlib.h>
+#include <Riostream.h>
+
+#include <TFile.h>
+#include <TGeometry.h>
+#include <TLorentzVector.h>
 #include <TMath.h>
 #include <TNode.h>
 #include <TPGON.h> 
-
-#include "AliTRD.h"
+#include <TParticle.h>
+#include <TROOT.h>
+#include <TTree.h>
+#include <TVirtualMC.h>
+#include "AliConst.h"
+#include "AliDigit.h"
+#include "AliLoader.h"
+#include "AliMagF.h"
 #include "AliRun.h"
+#include "AliTRD.h"
+#include "AliTRDdigit.h"
+#include "AliTRDdigitizer.h"
+#include "AliTRDdigitsManager.h"
+#include "AliTRDgeometryFull.h"
+#include "AliTRDgeometryHole.h"
+#include "AliTRDhit.h"
+#include "AliTRDpoints.h"
+#include "AliTRDrawData.h"
+#include "AliTrackReference.h"
+#include "AliMC.h"
 
-#include "AliConst.h"
 ClassImp(AliTRD)
  
 //_____________________________________________________________________________
@@ -32,16 +63,19 @@ AliTRD::AliTRD()
   // Default constructor
   //
 
-  fIshunt      = 0;
-  fGasMix      = 0;
+  fIshunt        = 0;
+  fGasMix        = 0;
+  fHits          = 0;
+  fDigits        = 0;
 
-  // The chamber dimensions
-  for (Int_t iplan = 0; iplan < kNplan; iplan++) {
-    fClengthI[iplan] = 0.;
-    fClengthM[iplan] = 0.;
-    fClengthO[iplan] = 0.;
-  }
+  fGeometry      = 0;
 
+  fGasDensity    = 0;
+  fFoilDensity   = 0;
+
+  fDrawTR        = 0;
+  fDisplayType   = 0;
 }
  
 //_____________________________________________________________________________
@@ -52,41 +86,240 @@ AliTRD::AliTRD(const char *name, const char *title)
   // Standard constructor for the TRD
   //
 
+  // Check that FRAME is there otherwise we have no place where to
+  // put TRD
+  AliModule* frame = gAlice->GetModule("FRAME");
+  if (!frame) {
+    Error("Ctor","TRD needs FRAME to be present\n");
+    exit(1);
+  } 
 
-  // Check that FRAME is there otherwise we have no place where to put the TRD
-  AliModule* FRAME = gAlice->GetModule("FRAME");
-  if (!FRAME) {
-    Error("AliTRD","TRD needs FRAME to be present\n");
+  // Define the TRD geometry
+  if ((frame->IsVersion() == 0) ||
+      (frame->IsVersion() == 1)) {
+    fGeometry = new AliTRDgeometryFull();
+  }
+  else {
+    Error("Ctor","Could not find valid FRAME version\n");
     exit(1);
   }
 
+  // Save the geometry
+  TDirectory* saveDir = gDirectory;
+  gAlice->GetRunLoader()->CdGAFile();
+  fGeometry->Write("TRDgeometry");
+  saveDir->cd();
+
   // Allocate the hit array
-  fHits   = new TClonesArray("AliTRDhit",  405);
-  
+  fHits           = new TClonesArray("AliTRDhit"     ,405);
+  gAlice->GetMCApp()->AddHitList(fHits);
+
+  // Allocate the digits array
+  fDigits         = 0;
+
+  fIshunt        = 0;
+  fGasMix        = 1;
+
+  fGasDensity    = 0;
+  fFoilDensity   = 0;
+
+  fDrawTR        = 0;
+  fDisplayType   = 0;
+
+  SetMarkerColor(kWhite);   
+
+}
+
+//_____________________________________________________________________________
+AliTRD::AliTRD(const AliTRD &trd):AliDetector(trd)
+{
+  //
+  // Copy constructor
+  //
+
+  ((AliTRD &) trd).Copy(*this);
+
+}
+
+//_____________________________________________________________________________
+AliTRD::~AliTRD()
+{
+  //
+  // TRD destructor
+  //
+
   fIshunt = 0;
-  fGasMix = 0;
-
-  // The chamber dimensions
-  for (Int_t iplan = 0; iplan < kNplan; iplan++) {
-    fClengthI[iplan] = 0.;
-    fClengthM[iplan] = 0.;
-    fClengthO[iplan] = 0.;
-    fCwidth[iplan]   = 0.;
+
+  if (fGeometry) {
+    delete fGeometry;
+    fGeometry  = 0;
+  }
+  if (fHits) {
+    delete fHits;
+    fHits      = 0;
   }
+
+}
+
+//_____________________________________________________________________________
+void AliTRD::Hits2Digits()
+{
+  //
+  // Create digits
+  //
+  AliTRDdigitizer digitizer("TRDdigitizer","TRD digitizer class");
+  digitizer.SetDebug(GetDebug());
   
-  SetMarkerColor(kWhite);   
+  // Initialization
+  digitizer.InitDetector();
+    
+  if (!fLoader->TreeH()) fLoader->LoadHits("read");
+  fLoader->LoadDigits("recreate");
+  AliRunLoader* runLoader = fLoader->GetRunLoader(); 
+
+  for (Int_t iEvent = 0; iEvent < runLoader->GetNumberOfEvents(); iEvent++) {
+    digitizer.Open(runLoader->GetFileName().Data(), iEvent);
+    digitizer.MakeDigits();
+    digitizer.WriteDigits();
+  }
+
+  fLoader->UnloadHits();
+  fLoader->UnloadDigits();
+
+}
+
+//_____________________________________________________________________________
+void AliTRD::Hits2SDigits()
+{
+  //
+  // Create summable digits
+  //
+
+  AliTRDdigitizer digitizer("TRDdigitizer","TRD digitizer class");
+  // For the summable digits
+  digitizer.SetSDigits(kTRUE);
+  digitizer.SetDebug(GetDebug());
+
+  // Initialization
+  digitizer.InitDetector();
+    
+  if (!fLoader->TreeH()) fLoader->LoadHits("read");
+  fLoader->LoadSDigits("recreate");
+  AliRunLoader* runLoader = fLoader->GetRunLoader(); 
+
+  for (Int_t iEvent = 0; iEvent < runLoader->GetNumberOfEvents(); iEvent++) {
+    digitizer.Open(runLoader->GetFileName().Data(), iEvent);
+    digitizer.MakeDigits();
+    digitizer.WriteDigits();
+  }
+
+  fLoader->UnloadHits();
+  fLoader->UnloadSDigits();
+  
+}
+
+//_____________________________________________________________________________
+AliDigitizer* AliTRD::CreateDigitizer(AliRunDigitizer* manager) const
+{
+  //
+  // Creates a new digitizer object
+  //
+
+  return new AliTRDdigitizer(manager);
 
 }
+
+//_____________________________________________________________________________
+void AliTRD::SDigits2Digits()
+{
+  //
+  // Create final digits from summable digits
+  //
+
+   // Create the TRD digitizer
+  AliTRDdigitizer digitizer("TRDdigitizer","TRD digitizer class");  
+  digitizer.SetDebug(GetDebug());
+
+  // Set the parameter
+  digitizer.SetEvent(gAlice->GetEvNumber());
+
+  // Initialization
+  digitizer.InitDetector();
+
+  // Read the s-digits via digits manager
+  AliTRDdigitsManager sdigitsManager;
  
+  sdigitsManager.SetDebug(GetDebug());
+  sdigitsManager.SetSDigits(kTRUE);
+  sdigitsManager.CreateArrays();
+  
+  if (!fLoader->TreeS()) 
+    if (fLoader->LoadSDigits("read"))
+     {
+       Error("SDigits2Digits","Error while reading SDigits for event %d",gAlice->GetEvNumber());
+       return;
+     }
+  if (!fLoader->TreeS()) return;
+  
+  sdigitsManager.ReadDigits(fLoader->TreeS());
+
+  // Add the s-digits to the input list 
+  digitizer.AddSDigitsManager(&sdigitsManager);
+
+  // Convert the s-digits to normal digits
+  digitizer.SDigits2Digits();
+
+  // Store the digits
+  if (!fLoader->TreeD()) fLoader->MakeTree("D");
+  if (digitizer.MakeBranch(fLoader->TreeD())){
+    digitizer.WriteDigits();
+  }
+
+}
+
 //_____________________________________________________________________________
-void AliTRD::AddHit(Int_t track, Int_t *vol, Float_t *hits)
+void AliTRD::Digits2Raw() 
 {
   //
-  // Add a hit for the TRD
+  // convert digits of the current event to raw data
+  //
+
+  fLoader->LoadDigits();
+  TTree* digits = fLoader->TreeD();
+  if (!digits) {
+    Error("Digits2Raw", "no digits tree");
+    return;
+  }
+
+  AliTRDrawData rawWriter;
+//  rawWriter.SetDebug(2);
+  if (!rawWriter.Digits2Raw(digits)) {
+    Error("AliTRD::Digits2Raw","The raw writer could not load the digits tree");
+  }
+
+  fLoader->UnloadDigits();
+
+}
+
+//_____________________________________________________________________________
+void AliTRD::AddHit(Int_t track, Int_t det, Float_t *hits, Int_t q
+                  , Bool_t inDrift)
+{
   //
+  // Add a hit for the TRD
+  // 
 
   TClonesArray &lhits = *fHits;
-  new(lhits[fNhits++]) AliTRDhit(fIshunt,track,vol,hits);
+  AliTRDhit *hit = new(lhits[fNhits++]) AliTRDhit(fIshunt,track,det,hits,q);
+  if (inDrift) {
+    hit->SetDrift();
+  }
+  else {
+    hit->SetAmplification();
+  }
+  if (q < 0) {
+    hit->SetTRphoton();
+  }
 
 }
 
@@ -97,376 +330,134 @@ void AliTRD::BuildGeometry()
   // Create the ROOT TNode geometry for the TRD
   //
 
-  TNode *Node, *Top;
+  TNode *node, *top;
   TPGON *pgon;
+
+  Float_t rmin, rmax;
+  Float_t zmax1, zmax2;
+
+  Int_t   iPlan;
   const Int_t kColorTRD = 46;
   
   // Find the top node alice
-  Top = gAlice->GetGeometry()->GetNode("alice");
+  top = gAlice->GetGeometry()->GetNode("alice");
   
-  pgon = new TPGON("S_TRD","TRD","void",0,360,kNsect,4);
-  Float_t ff    = TMath::Cos(kDegrad * 180 / kNsect);
-  Float_t rrmin = kRmin / ff;
-  Float_t rrmax = kRmax / ff;
-  pgon->DefineSection(0,-kZmax1,rrmax,rrmax);
-  pgon->DefineSection(1,-kZmax2,rrmin,rrmax);
-  pgon->DefineSection(2, kZmax2,rrmin,rrmax);
-  pgon->DefineSection(3, kZmax1,rrmax,rrmax);
-  Top->cd();
-  Node = new TNode("TRD","TRD","S_TRD",0,0,0,"");
-  Node->SetLineColor(kColorTRD);
-  fNodes->Add(Node);
+  if      (fDisplayType == 0) {
+
+    pgon = new TPGON("S_TRD","TRD","void",0,360,AliTRDgeometry::Nsect(),4);
+    rmin = AliTRDgeometry::Rmin();
+    rmax = AliTRDgeometry::Rmax();
+    pgon->DefineSection(0,-AliTRDgeometry::Zmax1(),rmax,rmax);
+    pgon->DefineSection(1,-AliTRDgeometry::Zmax2(),rmin,rmax);
+    pgon->DefineSection(2, AliTRDgeometry::Zmax2(),rmin,rmax);
+    pgon->DefineSection(3, AliTRDgeometry::Zmax1(),rmax,rmax);
+    top->cd();
+    node = new TNode("TRD","TRD","S_TRD",0,0,0,"");
+    node->SetLineColor(kColorTRD);
+    fNodes->Add(node);
+
+  }
+  else if (fDisplayType == 1) {
+
+    Char_t name[7];
+
+    Float_t slope = (AliTRDgeometry::Zmax1() - AliTRDgeometry::Zmax2())
+                  / (AliTRDgeometry::Rmax()  - AliTRDgeometry::Rmin());
+
+    rmin  = AliTRDgeometry::Rmin() + AliTRDgeometry::CraHght();
+    rmax  = rmin                   + AliTRDgeometry::CdrHght();
+
+    Float_t thickness = rmin - AliTRDgeometry::Rmin();
+    zmax2 = AliTRDgeometry::Zmax2() + slope * thickness;
+    zmax1 = zmax2 + slope * AliTRDgeometry::DrThick();
+
+    for (iPlan = 0; iPlan < AliTRDgeometry::Nplan(); iPlan++) {
+
+      sprintf(name,"S_TR1%d",iPlan);
+      pgon  = new TPGON(name,"TRD","void",0,360,AliTRDgeometry::Nsect(),4);
+      pgon->DefineSection(0,-zmax1,rmax,rmax);
+      pgon->DefineSection(1,-zmax2,rmin,rmax);
+      pgon->DefineSection(2, zmax2,rmin,rmax);
+      pgon->DefineSection(3, zmax1,rmax,rmax);
+      top->cd();
+      node = new TNode("TRD","TRD",name,0,0,0,"");
+      node->SetLineColor(kColorTRD);
+      fNodes->Add(node);
+
+      Float_t height = AliTRDgeometry::Cheight() + AliTRDgeometry::Cspace(); 
+      rmin  = rmin  + height;
+      rmax  = rmax  + height;
+      zmax1 = zmax1 + slope * height;
+      zmax2 = zmax2 + slope * height;
+
+    }
+
+    thickness += AliTRDgeometry::DrThick();
+    rmin  = AliTRDgeometry::Rmin() + thickness;
+    rmax  = rmin + AliTRDgeometry::AmThick();
+    zmax2 = AliTRDgeometry::Zmax2() + slope * thickness;
+    zmax1 = zmax2 + slope * AliTRDgeometry::AmThick();
+
+    for (iPlan = 0; iPlan < AliTRDgeometry::Nplan(); iPlan++) {
+
+      sprintf(name,"S_TR2%d",iPlan);
+      pgon  = new TPGON(name,"TRD","void",0,360,AliTRDgeometry::Nsect(),4);
+      pgon->DefineSection(0,-zmax1,rmax,rmax);
+      pgon->DefineSection(1,-zmax2,rmin,rmax);
+      pgon->DefineSection(2, zmax2,rmin,rmax);
+      pgon->DefineSection(3, zmax1,rmax,rmax);
+      top->cd();
+      node = new TNode("TRD","TRD",name,0,0,0,"");
+      node->SetLineColor(kColorTRD);
+      fNodes->Add(node);
+
+      Float_t height = AliTRDgeometry::Cheight() + AliTRDgeometry::Cspace(); 
+      rmin  = rmin  + height;
+      rmax  = rmax  + height;
+      zmax1 = zmax1 + slope * height;
+      zmax2 = zmax2 + slope * height;
+
+    }
+
+  }
 
 }
  
+//_____________________________________________________________________________
+void AliTRD::Copy(TObject &trd)
+{
+  //
+  // Copy function
+  //
+
+  ((AliTRD &) trd).fGasMix      = fGasMix;
+  ((AliTRD &) trd).fGeometry    = fGeometry;       
+  ((AliTRD &) trd).fGasDensity  = fGasDensity;
+  ((AliTRD &) trd).fFoilDensity = fFoilDensity;
+  ((AliTRD &) trd).fDrawTR      = fDrawTR;
+  ((AliTRD &) trd).fDisplayType = fDisplayType;
+
+  //AliDetector::Copy(trd);
+
+}
+
 //_____________________________________________________________________________
 void AliTRD::CreateGeometry()
 {
   //
   // Creates the volumes for the TRD chambers
   //
-  // Author: Christoph Blume (C.Blume@gsi.de) 20/07/99
-  //
-  // The volumes:
-  //    TRD        (Air)   --- The TRD mother volume for one sector. 
-  //                           To be placed into the spaceframe.
-  //
-  //    UAFI(/M/O) (Al)    --- The aluminum frame of the inner(/middle/outer) chambers (readout)
-  //    UCFI(/M/O) (C)     --- The carbon frame of the inner(/middle/outer) chambers 
-  //                           (driftchamber + radiator)
-  //    UAII(/M/O) (Air)   --- The inner part of the readout of the inner(/middle/outer) chambers
-  //    UFII(/M/O) (Air)   --- The inner part of the chamner and radiator of the 
-  //                           inner(/middle/outer) chambers
-  //
-  // The material layers in one chamber:
-  //    UL01       (G10)   --- The gas seal of the radiator
-  //    UL02       (CO2)   --- The gas in the radiator
-  //    UL03       (PE)    --- The foil stack
-  //    UL04       (Mylar) --- Entrance window to the driftvolume and HV-cathode
-  //    UL05       (Xe)    --- The driftvolume
-  //    UL06       (Xe)    --- The amplification region
-  //    
-  //    UL07       (Cu)    --- The pad plane
-  //    UL08       (G10)   --- The Nomex honeycomb support structure
-  //    UL09       (Cu)    --- FEE and signal lines
-  //    UL10       (PE)    --- The cooling devices
-  //    UL11       (Water) --- The cooling water
 
   // Check that FRAME is there otherwise we have no place where to put the TRD
-  AliModule* FRAME = gAlice->GetModule("FRAME");
-  if (!FRAME) return;
-
-  const Int_t npar_trd = 4;
-  const Int_t npar_cha = 3;
-
-  Float_t par_dum[3];
-  Float_t par_trd[npar_trd];
-  Float_t par_cha[npar_cha];
-
-  Float_t xpos, ypos, zpos;
-
-  Int_t *idtmed = fIdtmed->GetArray()-1299;
-
-  // The length of the inner chambers
-  for (Int_t iplan = 0; iplan < kNplan; iplan++) fClengthI[iplan] = 110.0;
-  // The length of the middle chambers
-  fClengthM[0] = 123.5;
-  fClengthM[1] = 131.0;
-  fClengthM[2] = 138.5;
-  fClengthM[3] = 146.0;
-  fClengthM[4] = 153.0;
-  fClengthM[5] = 160.5;
-  // The length of the outer chambers
-  fClengthO[0] = 123.5;
-  fClengthO[1] = 131.0;
-  fClengthO[2] = 134.5;
-  fClengthO[3] = 142.0;
-  fClengthO[4] = 142.0;
-  fClengthO[5] = 134.5;
-
-  // The width of the chambers
-  fCwidth[0] =  99.6;
-  fCwidth[1] = 104.1;
-  fCwidth[2] = 108.5;
-  fCwidth[3] = 112.9;
-  fCwidth[4] = 117.4;
-  fCwidth[5] = 121.8;
-
-  // The TRD mother volume for one sector (Air) (dimensions identical to BTR1-3)
-  par_trd[0] = kSwidth1/2.;
-  par_trd[1] = kSwidth2/2.;
-  par_trd[2] = kSlength/2.;
-  par_trd[3] = kSheight/2.;
-  gMC->Gsvolu("TRD ","TRD1",idtmed[1302-1],par_trd,npar_trd);
-
-  // The aluminum frames - readout + electronics (Al)
-  // The inner chambers
-  gMC->Gsvolu("UAFI","BOX ",idtmed[1301-1],par_dum,0);
-  // The middle chambers
-  gMC->Gsvolu("UAFM","BOX ",idtmed[1301-1],par_dum,0);
-  // The outer chambers
-  gMC->Gsvolu("UAFO","BOX ",idtmed[1301-1],par_dum,0);
-
-  // The inner part of the aluminum frames (Air)
-  // The inner chambers
-  gMC->Gsvolu("UAII","BOX ",idtmed[1302-1],par_dum,0);
-  // The middle chambers
-  gMC->Gsvolu("UAIM","BOX ",idtmed[1302-1],par_dum,0);
-  // The outer chambers
-  gMC->Gsvolu("UAIO","BOX ",idtmed[1302-1],par_dum,0);
-
-  // The carbon frames - radiator + driftchamber (C)
-  // The inner chambers
-  gMC->Gsvolu("UCFI","BOX ",idtmed[1307-1],par_dum,0);
-  // The middle chambers
-  gMC->Gsvolu("UCFM","BOX ",idtmed[1307-1],par_dum,0);
-  // The outer chambers
-  gMC->Gsvolu("UCFO","BOX ",idtmed[1307-1],par_dum,0);
-
-  // The inner part of the carbon frames (Air)
-  // The inner chambers
-  gMC->Gsvolu("UCII","BOX ",idtmed[1302-1],par_dum,0);
-  // The middle chambers
-  gMC->Gsvolu("UCIM","BOX ",idtmed[1302-1],par_dum,0);
-  // The outer chambers
-  gMC->Gsvolu("UCIO","BOX ",idtmed[1302-1],par_dum,0);
-
-  // The material layers inside the chambers
-  par_cha[0] = -1.;
-  par_cha[1] = -1.;
-  // G10 layer (radiator seal)
-  par_cha[2] = kSeThick/2;
-  gMC->Gsvolu("UL01","BOX ",idtmed[1313-1],par_cha,npar_cha);
-  // CO2 layer (radiator)
-  par_cha[2] = kRaThick/2;
-  gMC->Gsvolu("UL02","BOX ",idtmed[1312-1],par_cha,npar_cha);
-  // PE layer (radiator)
-  par_cha[2] = kPeThick/2;
-  gMC->Gsvolu("UL03","BOX ",idtmed[1303-1],par_cha,npar_cha);
-  // Mylar layer (entrance window + HV cathode) 
-  par_cha[2] = kMyThick/2;
-  gMC->Gsvolu("UL04","BOX ",idtmed[1308-1],par_cha,npar_cha);
-  // Xe/Isobutane layer (drift volume, sensitive) 
-  par_cha[2] = kDrThick/2.;
-  gMC->Gsvolu("UL05","BOX ",idtmed[1309-1],par_cha,npar_cha);
-  // Xe/Isobutane layer (amplification volume, not sensitive)
-  par_cha[2] = kAmThick/2.;
-  gMC->Gsvolu("UL06","BOX ",idtmed[1309-1],par_cha,npar_cha);
-  
-  // Cu layer (pad plane)
-  par_cha[2] = kCuThick/2;
-  gMC->Gsvolu("UL07","BOX ",idtmed[1305-1],par_cha,npar_cha);
-  // G10 layer (support structure)
-  par_cha[2] = kSuThick/2;
-  gMC->Gsvolu("UL08","BOX ",idtmed[1313-1],par_cha,npar_cha);
-  // Cu layer (FEE + signal lines)
-  par_cha[2] = kFeThick/2;
-  gMC->Gsvolu("UL09","BOX ",idtmed[1305-1],par_cha,npar_cha);
-  // PE layer (cooling devices)
-  par_cha[2] = kCoThick/2;
-  gMC->Gsvolu("UL10","BOX ",idtmed[1303-1],par_cha,npar_cha);
-  // Water layer (cooling)
-  par_cha[2] = kWaThick/2;
-  gMC->Gsvolu("UL11","BOX ",idtmed[1314-1],par_cha,npar_cha);
-
-  // Position the layers in the chambers
-  xpos = 0;
-  ypos = 0;
-
-  // G10 layer (radiator seal)
-  zpos = kSeZpos;
-  gMC->Gspos("UL01",1,"UCII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL01",2,"UCIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL01",3,"UCIO",xpos,ypos,zpos,0,"ONLY");
-  // CO2 layer (radiator)
-  zpos = kRaZpos;
-  gMC->Gspos("UL02",1,"UCII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL02",2,"UCIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL02",3,"UCIO",xpos,ypos,zpos,0,"ONLY");
-  // PE layer (radiator)
-  zpos = 0;
-  gMC->Gspos("UL03",1,"UL02",xpos,ypos,zpos,0,"ONLY");
-  // Mylar layer (entrance window + HV cathode)   
-  zpos = kMyZpos;
-  gMC->Gspos("UL04",1,"UCII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL04",2,"UCIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL04",3,"UCIO",xpos,ypos,zpos,0,"ONLY");
-  // Xe/Isobutane layer (drift volume) 
-  zpos = kDrZpos;
-  gMC->Gspos("UL05",1,"UCII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL05",2,"UCIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL05",3,"UCIO",xpos,ypos,zpos,0,"ONLY");
-  // Xe/Isobutane layer (amplification volume)
-  zpos = kAmZpos;
-  gMC->Gspos("UL06",1,"UCII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL06",2,"UCIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL06",3,"UCIO",xpos,ypos,zpos,0,"ONLY");
-
-  // Cu layer (pad plane)
-  zpos = kCuZpos;
-  gMC->Gspos("UL07",1,"UAII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL07",2,"UAIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL07",3,"UAIO",xpos,ypos,zpos,0,"ONLY");
-  // G10 layer (support structure)
-  zpos = kSuZpos;
-  gMC->Gspos("UL08",1,"UAII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL08",2,"UAIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL08",3,"UAIO",xpos,ypos,zpos,0,"ONLY");
-  // Cu layer (FEE + signal lines)
-  zpos = kFeZpos; 
-  gMC->Gspos("UL09",1,"UAII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL09",2,"UAIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL09",3,"UAIO",xpos,ypos,zpos,0,"ONLY");
-  // PE layer (cooling devices)
-  zpos = kCoZpos;
-  gMC->Gspos("UL10",1,"UAII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL10",2,"UAIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL10",3,"UAIO",xpos,ypos,zpos,0,"ONLY");
-  // Water layer (cooling)
-  zpos = kWaZpos;
-  gMC->Gspos("UL11",1,"UAII",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL11",1,"UAIM",xpos,ypos,zpos,0,"ONLY");
-  gMC->Gspos("UL11",1,"UAIO",xpos,ypos,zpos,0,"ONLY");
-
-  // Position the chambers in the TRD mother volume
-  for (Int_t iplan = 1; iplan <= kNplan; iplan++) {
-
-    // The inner chambers ---------------------------------------------------------------
-
-    // the aluminum frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2.;
-    par_cha[0] = fCwidth[iplan-1]/2.;
-    par_cha[1] = fClengthI[iplan-1]/2.;
-    par_cha[2] = kCaframe/2.;
-    xpos       = 0.;
-    ypos       = 0.;
-    zpos       = kCheight - kCaframe/2. - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UAFI",iplan       ,"TRD ",xpos,ypos,zpos,0,"MANY",par_cha,npar_cha);
-
-    // the inner part of the aluminum frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2. - kCathick;
-    par_cha[0] = fCwidth[iplan-1]/2.   - kCathick;
-    par_cha[1] = fClengthI[iplan-1]/2. - kCathick;
-    par_cha[2] = kCaframe/2.;
-    xpos       = 0.;
-    ypos       = 0.;
-    zpos       = kCheight - kCaframe/2. - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UAII",iplan       ,"TRD ",xpos,ypos,zpos,0,"ONLY",par_cha,npar_cha);
-
-    // the carbon frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2.;
-    par_cha[0] = fCwidth[iplan-1]/2.;
-    par_cha[1] = fClengthI[iplan-1]/2.;
-    par_cha[2] = kCcframe/2.;
-    xpos       = 0.;
-    ypos       = 0.;
-    zpos       = kCcframe/2.            - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UCFI",iplan       ,"TRD ",xpos,ypos,zpos,0,"MANY",par_cha,npar_cha);
-
-    // the inner part of the carbon frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2. - kCcthick;
-    par_cha[0] = fCwidth[iplan-1]/2.   - kCcthick;
-    par_cha[1] = fClengthI[iplan-1]/2. - kCcthick;
-    par_cha[2] = kCcframe/2.;
-    xpos       = 0.;
-    ypos       = 0.;
-    zpos       = kCcframe/2.            - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UCII",iplan       ,"TRD ",xpos,ypos,zpos,0,"ONLY",par_cha,npar_cha);
-
-    // The middle chambers --------------------------------------------------------------
-
-    // the aluminum frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2.;
-    par_cha[0] = fCwidth[iplan-1]/2.;
-    par_cha[1] = fClengthM[iplan-1]/2.;
-    par_cha[2] = kCaframe/2.;
-    xpos       = 0.;
-    ypos       = fClengthI[iplan-1]/2. + fClengthM[iplan-1]/2.;
-    zpos       = kCheight - kCaframe/2. - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UAFM",iplan       ,"TRD ",xpos, ypos,zpos,0,"MANY",par_cha,npar_cha);
-    gMC->Gsposp("UAFM",iplan+kNplan,"TRD ",xpos,-ypos,zpos,0,"MANY",par_cha,npar_cha);
-
-    // the inner part of the aluminum frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2. - kCathick;
-    par_cha[0] = fCwidth[iplan-1]/2.   - kCathick;
-    par_cha[1] = fClengthM[iplan-1]/2. - kCathick;
-    par_cha[2] = kCaframe/2.;
-    xpos       = 0.;
-    ypos       = fClengthI[iplan-1]/2. + fClengthM[iplan-1]/2.;
-    zpos       = kCheight - kCaframe/2. - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UAIM",iplan       ,"TRD ",xpos, ypos,zpos,0,"ONLY",par_cha,npar_cha);
-    gMC->Gsposp("UAIM",iplan+kNplan,"TRD ",xpos,-ypos,zpos,0,"ONLY",par_cha,npar_cha);
-
-    // the carbon frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2.;
-    par_cha[0] = fCwidth[iplan-1]/2.;
-    par_cha[1] = fClengthM[iplan-1]/2.;
-    par_cha[2] = kCcframe/2.;
-    xpos       = 0.;
-    ypos       = fClengthI[iplan-1]/2. + fClengthM[iplan-1]/2.;
-    zpos       = kCcframe/2.            - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UCFM",iplan,       "TRD ",xpos, ypos,zpos,0,"MANY",par_cha,npar_cha);
-    gMC->Gsposp("UCFM",iplan+kNplan,"TRD ",xpos,-ypos,zpos,0,"MANY",par_cha,npar_cha);
-
-    // the inner part of the carbon frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2. - kCcthick;
-    par_cha[0] = fCwidth[iplan-1]/2.   - kCcthick;
-    par_cha[1] = fClengthM[iplan-1]/2. - kCcthick;
-    par_cha[2] = kCcframe/2.;
-    xpos       = 0.;
-    ypos       = fClengthI[iplan-1]/2. + fClengthM[iplan-1]/2.;
-    zpos       = kCcframe/2.            - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UCIM",iplan       ,"TRD ",xpos, ypos,zpos,0,"ONLY",par_cha,npar_cha);
-    gMC->Gsposp("UCIM",iplan+kNplan,"TRD ",xpos,-ypos,zpos,0,"ONLY",par_cha,npar_cha);
-
-    // The outer chambers ---------------------------------------------------------------
-
-    // the aluminum frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2.;
-    par_cha[0] = fCwidth[iplan-1]/2.;
-    par_cha[1] = fClengthO[iplan-1]/2.;
-    par_cha[2] = kCaframe/2.;
-    xpos       = 0.;
-    ypos       = fClengthI[iplan-1]/2. + fClengthM[iplan-1]    + fClengthO[iplan-1]/2.;
-    zpos       = kCheight - kCaframe/2. - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UAFO",iplan       ,"TRD ",xpos, ypos,zpos,0,"MANY",par_cha,npar_cha);
-    gMC->Gsposp("UAFO",iplan+kNplan,"TRD ",xpos,-ypos,zpos,0,"MANY",par_cha,npar_cha);
-
-    // the inner part of the aluminum frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2. - kCathick;
-    par_cha[0] = fCwidth[iplan-1]/2.   - kCathick;
-    par_cha[1] = fClengthO[iplan-1]/2.  - kCathick;
-    par_cha[2] = kCaframe/2.;
-    xpos       = 0.;
-    ypos       = fClengthI[iplan-1]/2. + fClengthM[iplan-1]    + fClengthO[iplan-1]/2.;
-    zpos       = kCheight - kCaframe/2. - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UAIO",iplan       ,"TRD ",xpos, ypos,zpos,0,"ONLY",par_cha,npar_cha);
-    gMC->Gsposp("UAIO",iplan+kNplan,"TRD ",xpos,-ypos,zpos,0,"ONLY",par_cha,npar_cha);
-
-    // the carbon frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2.;
-    par_cha[0] = fCwidth[iplan-1]/2.;
-    par_cha[1] = fClengthO[iplan-1]/2.;
-    par_cha[2] = kCcframe/2.;
-    xpos       = 0.;
-    ypos       = fClengthI[iplan-1]/2. + fClengthM[iplan-1]    + fClengthO[iplan-1]/2.;
-    zpos       = kCcframe/2.            - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UCFO",iplan,       "TRD ",xpos, ypos,zpos,0,"MANY",par_cha,npar_cha);
-    gMC->Gsposp("UCFO",iplan+kNplan,"TRD ",xpos,-ypos,zpos,0,"MANY",par_cha,npar_cha);
-
-    // the inner part of the carbon frame
-    //par_cha[0] = kSwidth1/2. + (iplan-1) * kCwidcha/2. - kCcthick;
-    par_cha[0] = fCwidth[iplan-1]/2.   - kCcthick;
-    par_cha[1] = fClengthO[iplan-1]/2. - kCcthick;
-    par_cha[2] = kCcframe/2.;
-    xpos       = 0.;
-    ypos       = fClengthI[iplan-1]/2. + fClengthM[iplan-1]    + fClengthO[iplan-1]/2.;
-    zpos       = kCcframe/2.            - kSheight/2. + (iplan-1) * (kCheight + kCspace);
-    gMC->Gsposp("UCIO",iplan       ,"TRD ",xpos, ypos,zpos,0,"ONLY",par_cha,npar_cha);
-    gMC->Gsposp("UCIO",iplan+kNplan,"TRD ",xpos,-ypos,zpos,0,"ONLY",par_cha,npar_cha);
-
+  AliModule* frame = gAlice->GetModule("FRAME");
+  if (!frame) {
+    printf(" The TRD needs the FRAME to be defined first\n");
+    return;
   }
 
+  fGeometry->CreateGeometry(fIdtmed->GetArray() - 1299);
+
 }
  
 //_____________________________________________________________________________
@@ -477,8 +468,8 @@ void AliTRD::CreateMaterials()
   // Origin Y.Foka
   //
 
-  Int_t   ISXFLD = gAlice->Field()->Integ();
-  Float_t SXMGMX = gAlice->Field()->Max();
+  Int_t   isxfld = gAlice->Field()->Integ();
+  Float_t sxmgmx = gAlice->Field()->Max();
   
   // For polyethilene (CH2) 
   Float_t ape[2] = { 12., 1. };
@@ -510,9 +501,37 @@ void AliTRD::CreateMaterials()
   Float_t wis[2] = {  4., 10. };
   Float_t dis    = 0.00267;
 
+  // For plexiglas (C5H8O2)
+  Float_t apg[3] = { 12.011 ,  1.0    , 15.9994 };
+  Float_t zpg[3] = {  6.0   ,  1.0    ,  8.0    };
+  Float_t wpg[3] = {  5.0   ,  8.0    ,  2.0    };
+  Float_t dpg    = 1.18; 
+  
+  // For epoxy (C18H19O3)
+  Float_t aEpoxy[3] = { 15.9994 ,  1.00794 , 12.0107 }; 
+  Float_t zEpoxy[3] = {  8.0    ,  1.0     ,  6.0    }; 
+  Float_t wEpoxy[3] = {  3.0    , 19.0     , 18.0    }; 
+  Float_t dEpoxy    = 1.8 ; 
+
+  // For air  
+  Float_t aAir[4]   = { 12.0      , 14.0      , 16.0      , 36.0     };
+  Float_t zAir[4]   = {  6.0      ,  7.0      ,  8.0      , 18.0     };
+  Float_t wAir[4]   = {  0.000124 ,  0.755267 ,  0.231781 ,  0.012827};
+  Float_t dAir      = 1.20479E-3;
+
+  // For G10
+  Float_t aG10[4]   = {  1.0         , 12.011       , 15.9994      , 28.086       };
+  Float_t zG10[4]   = {  1.0         ,  6.0         ,  8.0         , 14.0         };
+  //PH  Float_t wG10[4]   = {  0.148648649 ,  0.104054054 ,  0.483499056 ,  0.241666667 };
+  Float_t wG10[4]={0.15201,0.10641,0.49444,0.24714};
+  Float_t dG10      = 1.7;
+
   // For Xe/CO2-gas-mixture 
-  // Xe-content of the Xe/CO2-mixture (90% / 10%) 
-  Float_t fxc    = .90;
+  Float_t aXeCO2[3] = { 39.948, 12.0107, 15.9994 };
+  Float_t zXeCO2[3] = { 18.0,    6.0,     8.0    };
+  Float_t wXeCO2[3] = {  0.85,   0.0375,  0.1125 };
+  // Xe-content of the Xe/CO2-mixture (85% / 15%) 
+  Float_t fxc    = .85;
   // Xe-content of the Xe/Isobutane-mixture (97% / 3%) 
   Float_t fxi    = .97;
   Float_t dxe    = .005858;
@@ -525,39 +544,48 @@ void AliTRD::CreateMaterials()
   Float_t stmin  = -0.001;
   
   Float_t absl, radl, d, buf[1];
-  Float_t agm[2], dgm, zgm[2], wgm[2];
+  Float_t agm[2], zgm[2], wgm[2];
+  Float_t dgm1, dgm2;
   Int_t   nbuf;
   
   //////////////////////////////////////////////////////////////////////////
   //     Define Materials 
   //////////////////////////////////////////////////////////////////////////
 
-  AliMaterial( 1, "Al $",  26.98, 13.0, 2.7     ,     8.9 ,    37.2);
-  AliMaterial( 2, "Air$",  14.61,  7.3, 0.001205, 30420.0 , 67500.0);
-  AliMaterial( 4, "Xe $", 131.29, 54.0, dxe     ,  1447.59,     0.0);
-  AliMaterial( 5, "Cu $",  63.54, 29.0, 8.96    ,     1.43,    14.8);
-  AliMaterial( 6, "C  $",  12.01,  6.0, 2.265   ,    18.8 ,    74.4);
-  AliMaterial(12, "G10$",  20.00, 10.0, 1.7     ,    19.4 ,   999.0);
+  AliMaterial( 1, "Al"   ,  26.98, 13.0, 2.7     ,     8.9 ,    37.2);
+  //AliMaterial( 2, "Air"  ,  14.61,  7.3, 0.001205, 30420.0 , 67500.0);
+  AliMaterial( 4, "Xe"   , 131.29, 54.0, dxe     ,  1447.59,     0.0);
+  AliMaterial( 5, "Cu"   ,  63.54, 29.0, 8.96    ,     1.43,    14.8);
+  AliMaterial( 6, "C"    ,  12.01,  6.0, 2.265   ,    18.8 ,    74.4);
+  //AliMaterial(12, "G10"  ,  20.00, 10.0, 1.7     ,    19.4 ,   999.0);
+  AliMaterial(15, "Sn"   , 118.71, 50.0, 7.31    ,     1.21,    14.8);
+  AliMaterial(16, "Si"   ,  28.09, 14.0, 2.33    ,     9.36,    37.2);
+  //AliMaterial(17, "Epoxy",  17.75,  8.9, 1.8     ,    21.82,   999.0);
 
   // Mixtures 
-  AliMixture(3, "Polyethilene$",   ape, zpe, dpe, -2, wpe);
-  AliMixture(7, "Mylar$",          amy, zmy, dmy, -3, wmy);
-  AliMixture(8, "CO2$",            aco, zco, dco, -2, wco);
-  AliMixture(9, "Isobutane$",      ais, zis, dis, -2, wis);
-  AliMixture(13,"Water$",          awa, zwa, dwa, -2, wwa);
+  AliMixture(2, "Air"         ,  aAir,  zAir,  dAir,  4,   wAir);
+  AliMixture(3, "Polyethilene",   ape,   zpe,   dpe, -2,    wpe);
+  AliMixture(7, "Mylar",          amy,   zmy,   dmy, -3,    wmy);
+  AliMixture(8, "CO2",            aco,   zco,   dco, -2,    wco);
+  AliMixture(9, "Isobutane",      ais,   zis,   dis, -2,    wis);
+  AliMixture(12,"G10",           aG10,  zG10,  dG10,  4,   wG10);
+  AliMixture(13,"Water",          awa,   zwa,   dwa, -2,    wwa);
+  AliMixture(14,"Plexiglas",      apg,   zpg,   dpg, -3,    wpg);
+  AliMixture(17,"Epoxy",       aEpoxy,zEpoxy,dEpoxy, -3, wEpoxy);
 
   // Gas mixtures
-  Char_t namate[21];
+  Char_t namate[21]="";
   // Xe/CO2-mixture
   // Get properties of Xe 
-  gMC->Gfmate((*fIdmate)[4], namate, agm[0], zgm[0], d, radl, absl, buf, nbuf);
+  //gMC->Gfmate((*fIdmate)[4], namate, agm[0], zgm[0], d, radl, absl, buf, nbuf);
   // Get properties of CO2 
-  gMC->Gfmate((*fIdmate)[8], namate, agm[1], zgm[1], d, radl, absl, buf, nbuf);
+  //gMC->Gfmate((*fIdmate)[8], namate, agm[1], zgm[1], d, radl, absl, buf, nbuf);
   // Create gas mixture 
   wgm[0] = fxc;
   wgm[1] = 1. - fxc;
-  dgm    = wgm[0] * dxe + wgm[1] * dco;
-  AliMixture(10, "Gas mixture 1$", agm, zgm, dgm,  2, wgm);
+  dgm1   = wgm[0] * dxe + wgm[1] * dco;
+  AliMixture(10, "Gas mixture 1", aXeCO2, zXeCO2, dgm1,  3, wXeCO2);
+
   // Xe/Isobutane-mixture
   // Get properties of Xe 
   gMC->Gfmate((*fIdmate)[4], namate, agm[0], zgm[0], d, radl, absl, buf, nbuf);
@@ -566,67 +594,107 @@ void AliTRD::CreateMaterials()
   // Create gas mixture 
   wgm[0] = fxi;
   wgm[1] = 1. - fxi;
-  dgm    = wgm[0] * dxe + wgm[1] * dis;
-  AliMixture(11, "Gas mixture 2$", agm, zgm, dgm,  2, wgm);
+  dgm2   = wgm[0] * dxe + wgm[1] * dis;
+  AliMixture(11, "Gas mixture 2", agm, zgm, dgm2,  2, wgm);
  
   //////////////////////////////////////////////////////////////////////////
   //     Tracking Media Parameters 
   //////////////////////////////////////////////////////////////////////////
 
   // Al Frame 
-  AliMedium(1, "Al Frame$",   1, 0, ISXFLD, SXMGMX
+  AliMedium(1, "Al Frame",   1, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Air 
-  AliMedium(2, "Air$",        2, 0, ISXFLD, SXMGMX
+  AliMedium(2, "Air",        2, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Polyethilene 
-  AliMedium(3, "Radiator$",   3, 0, ISXFLD, SXMGMX
+  AliMedium(3, "Radiator",   3, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Xe 
-  AliMedium(4, "Xe$",         4, 1, ISXFLD, SXMGMX
+  AliMedium(4, "Xe",         4, 1, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Cu pads 
-  AliMedium(5, "Padplane$",   5, 1, ISXFLD, SXMGMX
+  AliMedium(5, "Padplane",   5, 1, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Fee + cables 
-  AliMedium(6, "Readout$",    1, 0, ISXFLD, SXMGMX
+  AliMedium(6, "Readout",    1, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // C frame 
-  AliMedium(7, "C Frame$",    6, 0, ISXFLD, SXMGMX
+  AliMedium(7, "C Frame",    6, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Mylar foils 
-  AliMedium(8, "Mylar$",      7, 0, ISXFLD, SXMGMX
+  AliMedium(8, "Mylar",      7, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   if (fGasMix == 1) {
     // Gas-mixture (Xe/CO2) 
-    AliMedium(9, "Gas-mix$",   10, 1, ISXFLD, SXMGMX
+    AliMedium(9, "Gas-mix",   10, 1, isxfld, sxmgmx
                   , tmaxfd, stemax, deemax, epsil, stmin);
   }
   else {
     // Gas-mixture (Xe/Isobutane) 
-    AliMedium(9, "Gas-mix$",   11, 1, ISXFLD, SXMGMX
+    AliMedium(9, "Gas-mix",   11, 1, isxfld, sxmgmx
                   , tmaxfd, stemax, deemax, epsil, stmin);
   }
   // Nomex-honeycomb (use carbon for the time being) 
-  AliMedium(10, "Nomex$",      6, 0, ISXFLD, SXMGMX
+  AliMedium(10, "Nomex",      6, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Kapton foils (use Mylar for the time being) 
-  AliMedium(11, "Kapton$",     7, 0, ISXFLD, SXMGMX
+  AliMedium(11, "Kapton",     7, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Gas-filling of the radiator 
-  AliMedium(12, "CO2$",        8, 0, ISXFLD, SXMGMX
+  AliMedium(12, "CO2",        8, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // G10-plates
-  AliMedium(13, "G10-plates$",12, 0, ISXFLD, SXMGMX
+  AliMedium(13, "G10-plates",12, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
   // Cooling water
-  AliMedium(14, "Water$",     13, 0, ISXFLD, SXMGMX
+  AliMedium(14, "Water",     13, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Rohacell (plexiglas) for the radiator
+  AliMedium(15, "Rohacell",  14, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Al layer in MCMs
+  AliMedium(16, "MCM-Al"  ,   1, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Sn layer in MCMs
+  AliMedium(17, "MCM-Sn"  ,  15, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Cu layer in MCMs
+  AliMedium(18, "MCM-Cu"  ,   5, 0, isxfld, sxmgmx
                 , tmaxfd, stemax, deemax, epsil, stmin);
+  // G10 layer in MCMs
+  AliMedium(19, "MCM-G10" ,  12, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Si in readout chips
+  AliMedium(20, "Chip-Si" ,  16, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Epoxy in readout chips
+  AliMedium(21, "Chip-Ep" ,  17, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // PE in connectors
+  AliMedium(22, "Conn-PE" ,   3, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Cu in connectors
+  AliMedium(23, "Chip-Cu" ,   5, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Al of cooling pipes
+  AliMedium(24, "Cooling" ,   1, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+  // Cu in services
+  AliMedium(25, "Serv-Cu" ,   5, 0, isxfld, sxmgmx
+                , tmaxfd, stemax, deemax, epsil, stmin);
+
+  // Save the density values for the TRD absorbtion
+  fFoilDensity = dmy;
+  if (fGasMix == 1)
+    fGasDensity = dgm1;
+  else
+    fGasDensity = dgm2;
 
 }
 
 //_____________________________________________________________________________
-void AliTRD::DrawModule()
+void AliTRD::DrawModule() const
 {
   //
   // Draw a shaded view of the Transition Radiation Detector version 0
@@ -639,20 +707,38 @@ void AliTRD::DrawModule()
   gMC->Gsatt("ALIC","SEEN", 0);
   
   // Set the volumes visible
-  gMC->Gsatt("B032","SEEN", 0);
-  gMC->Gsatt("B028","SEEN", 0);
-  gMC->Gsatt("B029","SEEN", 0);
-  gMC->Gsatt("B030","SEEN", 0);
-  gMC->Gsatt("BTR1","SEEN", 0);
-  gMC->Gsatt("BTR2","SEEN", 0);
-  gMC->Gsatt("BTR3","SEEN", 0);
-  gMC->Gsatt("TRD" ,"SEEN", 0);
-  gMC->Gsatt("UCII","SEEN", 0);
-  gMC->Gsatt("UCIM","SEEN", 0);
-  gMC->Gsatt("UCIO","SEEN", 0);
-  gMC->Gsatt("UL02","SEEN", 1);
-  gMC->Gsatt("UL05","SEEN", 1);
-  gMC->Gsatt("UL06","SEEN", 1);
+  if (fGeometry->IsVersion() == 0) {
+    gMC->Gsatt("B071","SEEN", 0);
+    gMC->Gsatt("B074","SEEN", 0);
+    gMC->Gsatt("B075","SEEN", 0);
+    gMC->Gsatt("B077","SEEN", 0);
+    gMC->Gsatt("BTR1","SEEN", 0);
+    gMC->Gsatt("BTR2","SEEN", 0);
+    gMC->Gsatt("BTR3","SEEN", 0);
+    gMC->Gsatt("UTR1","SEEN", 0);
+    gMC->Gsatt("UTR2","SEEN", 0);
+    gMC->Gsatt("UTR3","SEEN", 0);
+  }
+  else {
+    gMC->Gsatt("B071","SEEN", 0);
+    gMC->Gsatt("B074","SEEN", 0);
+    gMC->Gsatt("B075","SEEN", 0);
+    gMC->Gsatt("B077","SEEN", 0);
+    gMC->Gsatt("BTR1","SEEN", 0);
+    gMC->Gsatt("BTR2","SEEN", 0);
+    gMC->Gsatt("BTR3","SEEN", 0);
+    gMC->Gsatt("UTR1","SEEN", 0);
+    if (fGeometry->GetPHOShole())
+      gMC->Gsatt("UTR2","SEEN", 0);
+    if (fGeometry->GetRICHhole())
+      gMC->Gsatt("UTR3","SEEN", 0);
+  }
+//   gMC->Gsatt("UCII","SEEN", 0);
+//   gMC->Gsatt("UCIM","SEEN", 0);
+//   gMC->Gsatt("UCIO","SEEN", 0);
+//   gMC->Gsatt("UL02","SEEN", 1);
+//   gMC->Gsatt("UL05","SEEN", 1);
+//   gMC->Gsatt("UL06","SEEN", 1);
   
   gMC->Gdopt("hide", "on");
   gMC->Gdopt("shad", "on");
@@ -667,7 +753,7 @@ void AliTRD::DrawModule()
 }
 
 //_____________________________________________________________________________
-Int_t AliTRD::DistancetoPrimitive(Int_t , Int_t )
+Int_t AliTRD::DistancetoPrimitive(Int_t , Int_t ) const
 {
   //
   // Distance between the mouse and the TRD detector on the screen
@@ -681,22 +767,220 @@ Int_t AliTRD::DistancetoPrimitive(Int_t , Int_t )
 void AliTRD::Init()
 {
   //
-  // Initialise the TRD detector after the geometry has been created
+  // Initialize the TRD detector after the geometry has been created
   //
 
   Int_t i;
+
+  if (fDebug) {
+    printf("\n%s: ",ClassName());
+    for (i = 0; i < 35; i++) printf("*");
+    printf(" TRD_INIT ");
+    for (i = 0; i < 35; i++) printf("*");
+    printf("\n");
+  }
+
+  if (fGeometry->IsVersion() == 1) {
+    printf("%s: Full geometry version initialized\n",ClassName());
+    if (fGeometry->GetPHOShole())
+      printf("%s: Leave space in front of PHOS free\n",ClassName());
+    if (fGeometry->GetRICHhole())
+      printf("%s: Leave space in front of RICH free\n",ClassName());
+  }
+  else {
+    printf("%s: Not a valid geometry\n",ClassName());
+  }
+  
+  if (fGasMix == 1) {
+    printf("%s: Gas Mixture: 85%% Xe + 15%% CO2\n",ClassName());
+  }
+  else {
+    printf("%s: Gas Mixture: 97%% Xe + 3%% Isobutane\n",ClassName());
+  }
+
+}
+
+//_____________________________________________________________________________
+void AliTRD::LoadPoints(Int_t )
+{
+  //
+  // Store x, y, z of all hits in memory.
+  // Hit originating from TR photons are given a different color
+  //
+
+  //if (!fDrawTR) {
+  //  AliDetector::LoadPoints(track);
+  //  return;
+  //}
+
+  if (fHits == 0) return;
+
+  Int_t nhits = fHits->GetEntriesFast();
+  if (nhits == 0) return;
+
+  Int_t tracks = gAlice->GetMCApp()->GetNtrack();
+  if (fPoints == 0) fPoints = new TObjArray(tracks);
+
+  AliTRDhit *ahit;
   
-  printf("\n");
-  for(i=0;i<35;i++) printf("*");
-  printf(" TRD_INIT ");
-  for(i=0;i<35;i++) printf("*");
-  printf("\n");
+  Int_t    *ntrkE = new Int_t[tracks];
+  Int_t    *ntrkT = new Int_t[tracks];
+  Int_t    *limiE = new Int_t[tracks];
+  Int_t    *limiT = new Int_t[tracks];
+  Float_t **coorE = new Float_t*[tracks];
+  Float_t **coorT = new Float_t*[tracks];
+  for(Int_t i = 0; i < tracks; i++) {
+    ntrkE[i] = 0;
+    ntrkT[i] = 0;
+    coorE[i] = 0;
+    coorT[i] = 0;
+    limiE[i] = 0;
+    limiT[i] = 0;
+  }
   
-  // Here the TRD initialisation code (if any!)
-  if (fGasMix == 1) 
-    printf("          Gas Mixture: 90%% Xe + 10%% CO2\n");
-  else
-    printf("          Gas Mixture: 97%% Xe + 3%% Isobutane\n");
+  AliTRDpoints *points = 0;
+  Float_t      *fp     = 0;
+  Int_t         trk;
+  Int_t         chunk  = nhits / 4 + 1;
+
+  // Loop over all the hits and store their position
+  ahit = (AliTRDhit *) FirstHit(-1);
+  while (ahit) {
+
+    // dEdx hits
+    if (ahit->GetCharge() >= 0) {
+
+      trk = ahit->GetTrack();
+      if (ntrkE[trk] == limiE[trk]) {
+        // Initialise a new track
+        fp = new Float_t[3*(limiE[trk]+chunk)];
+        if (coorE[trk]) {
+          memcpy(fp,coorE[trk],sizeof(Float_t)*3*limiE[trk]);
+          delete [] coorE[trk];
+        }
+        limiE[trk] += chunk;
+        coorE[trk]  = fp;
+      } 
+      else {
+        fp = coorE[trk];
+      }
+      fp[3*ntrkE[trk]  ] = ahit->X();
+      fp[3*ntrkE[trk]+1] = ahit->Y();
+      fp[3*ntrkE[trk]+2] = ahit->Z();
+      ntrkE[trk]++;
+
+    }
+    // TR photon hits
+    else if ((ahit->GetCharge() < 0) && (fDrawTR)) {
+
+      trk = ahit->GetTrack();
+      if (ntrkT[trk] == limiT[trk]) {
+        // Initialise a new track
+        fp = new Float_t[3*(limiT[trk]+chunk)];
+        if (coorT[trk]) {
+          memcpy(fp,coorT[trk],sizeof(Float_t)*3*limiT[trk]);
+          delete [] coorT[trk];
+        }
+        limiT[trk] += chunk;
+        coorT[trk]  = fp;
+      } 
+      else {
+        fp = coorT[trk];
+      }
+      fp[3*ntrkT[trk]  ] = ahit->X();
+      fp[3*ntrkT[trk]+1] = ahit->Y();
+      fp[3*ntrkT[trk]+2] = ahit->Z();
+      ntrkT[trk]++;
+
+    }
+
+    ahit = (AliTRDhit *) NextHit();
+
+  }
+
+  for (trk = 0; trk < tracks; ++trk) {
+
+    if (ntrkE[trk] || ntrkT[trk]) {
+
+      points = new AliTRDpoints();
+      points->SetDetector(this);
+      points->SetParticle(trk);
+
+      // Set the dEdx points
+      if (ntrkE[trk]) {
+        points->SetMarkerColor(GetMarkerColor());
+        points->SetMarkerSize(GetMarkerSize());
+        points->SetPolyMarker(ntrkE[trk],coorE[trk],GetMarkerStyle());
+        delete [] coorE[trk];
+        coorE[trk] = 0;
+      }
+
+      // Set the TR photon points
+      if (ntrkT[trk]) {
+        points->SetTRpoints(ntrkT[trk],coorT[trk]);
+        delete [] coorT[trk];
+        coorT[trk] = 0;
+      }
+
+      fPoints->AddAt(points,trk);
+
+    }
+
+  }
+
+  delete [] coorE;
+  delete [] coorT;
+  delete [] ntrkE;
+  delete [] ntrkT;
+  delete [] limiE;
+  delete [] limiT;
+
+}
+
+//_____________________________________________________________________________
+void AliTRD::MakeBranch(Option_t* option)
+{
+  //
+  // Create Tree branches for the TRD digits.
+  //
+
+  Int_t  buffersize = 4000;
+  Char_t branchname[15];
+  sprintf(branchname,"%s",GetName());
+
+  const char *cD = strstr(option,"D");
+
+  AliDetector::MakeBranch(option);
+
+  if (fDigits && gAlice->TreeD() && cD) {
+    MakeBranchInTree(gAlice->TreeD(),branchname,&fDigits,buffersize,0);
+  }    
+
+}
+
+//_____________________________________________________________________________
+void AliTRD::ResetDigits()
+{
+  //
+  // Reset number of digits and the digits array for this detector
+  //
+
+  fNdigits = 0;
+  if (fDigits) fDigits->Clear();
+
+}
+
+//_____________________________________________________________________________
+void AliTRD::SetTreeAddress()
+{
+  //
+  // Set the branch addresses for the trees.
+  //
+
+  if ( fLoader->TreeH() && (fHits == 0x0)) {
+    fHits = new TClonesArray("AliTRDhit",405);
+  }
+  AliDetector::SetTreeAddress();
 
 }
 
@@ -710,7 +994,7 @@ void AliTRD::SetGasMix(Int_t imix)
   if ((imix < 0) || (imix > 1)) {
     printf("Wrong input value: %d\n",imix);
     printf("Use standard setting\n");
-    fGasMix = 0;
+    fGasMix = 1;
     return;
   }
 
@@ -718,25 +1002,371 @@ void AliTRD::SetGasMix(Int_t imix)
 
 }
 
-ClassImp(AliTRDhit)
 //_____________________________________________________________________________
-AliTRDhit::AliTRDhit(Int_t shunt, Int_t track, Int_t *vol, Float_t *hits):
-  AliHit(shunt, track)
+void AliTRD::SetPHOShole()
 {
   //
-  // Create a TRD hit
+  // Selects a geometry with a hole in front of the PHOS
   //
 
-  // Store volume hierarchy
-  fSector  = vol[0]; 
-  fChamber = vol[1];
-  fPlane   = vol[2];
-  
-  // Store position and charge
-  fX       = hits[0];
-  fY       = hits[1];
-  fZ       = hits[2];
-  fQ       = hits[3];
+  fGeometry->SetPHOShole();
+
+}
+
+//_____________________________________________________________________________
+void AliTRD::SetRICHhole()
+{
+  //
+  // Selects a geometry with a hole in front of the RICH
+  //
+
+  fGeometry->SetRICHhole();
 
 }
+
+//_____________________________________________________________________________
+AliTRD &AliTRD::operator=(const AliTRD &trd)
+{
+  //
+  // Assignment operator
+  //
+
+  if (this != &trd) ((AliTRD &) trd).Copy(*this);
+  return *this;
+
+} 
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+