]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - ITS/AliITSv11.cxx
Fix for coverity (Annalisa De Caro).
[u/mrichter/AliRoot.git] / ITS / AliITSv11.cxx
index 88d73b1238648f6c36ff3ab9358ddbb4c3b23cad..97fb27644525118846cbaef0eb60b0afc270e30f 100644 (file)
@@ -1,5 +1,5 @@
 /**************************************************************************
- * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ * Copyright(c) 2007-2009, ALICE Experiment at CERN, All rights reserved. *
  *                                                                        *
  * Author: The ALICE Off-line Project.                                    *
  * Contributors are mentioned in the code where appropriate.              *
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
 
-/* $Id$ */
-
-//////////////////////////////////////////////////////////////////////////////
-//                                                                          //
-//  Inner Traking System version 11                                         //
-//  This class contains the base procedures for the Inner Tracking System   //
-//                                                                          //
-// Authors: R. Barbera                                                      //
-// version 6.                                                               //
-// Created  2000.                                                           //
-//                                                                          //
-//  NOTE: THIS IS THE  SYMMETRIC PPR geometry of the ITS.                   //
-// THIS WILL NOT WORK                                                       //
-// with the geometry or module classes or any analysis classes. You are     //
-// strongly encouraged to uses AliITSv5.                                    //
-//                                                                          //
-//////////////////////////////////////////////////////////////////////////////
-// See AliITSv11::StepManager().
-// General C/C++ includes
-#include <stdio.h>
-#include <stdlib.h>
-// General Root includes
-#include <Riostream.h>
-#include <TMath.h>
-#include <TFile.h>    // only required for Tracking function?
-#include <TObjArray.h>
+
+/* $Id: */
+
+
+//========================================================================
+//
+//            Geometry of the Inner Tracking System
+//           ---------------------------------------
+//  This geometry is fully described in TGeo geometry (v11)
+// 
+// Ludovic Gaudichet  (gaudichet@to.infn.it)
+// Mario Sitta (sitta@to.infn.it)
+//
+//========================================================================
+
+
+// $Log$
+// Revision 1.1  2011/06/10 14:48:24  masera
+// First version from v11Hybrid to v11 (M. Sitta)
+//
+
+
 #include <TClonesArray.h>
-#include <TLorentzVector.h>
-#include <TObjString.h>
-// Root Geometry includes
+#include <TGeoGlobalMagField.h>
 #include <TGeoManager.h>
-#include <TGeoVolume.h>
-#include <TGeoPcon.h>
-#include <TGeoCone.h>
-#include <TGeoTube.h> // contaings TGeoTubeSeg
-#include <TGeoArb8.h>
-#include <TGeoCompositeShape.h>
 #include <TGeoMatrix.h>
-#include <TGeoNode.h>
-#include <TGeoMaterial.h>
-#include <TGeoMedium.h>
-// General AliRoot includes
-#include "AliRun.h"
-#include "AliMagF.h"
-#include "AliConst.h"
-// ITS specific includes
+#include <TGeoPhysicalNode.h>
+#include <TGeoVolume.h>
+#include <TGeoXtru.h>
+#include <TLorentzVector.h>
+#include <TString.h>
+#include <TVirtualMC.h>
+
+#include "AliITS.h"
+#include "AliITSDetTypeSim.h"
 #include "AliITShit.h"
-#include "AliITSgeom.h"
-#include "AliITSgeomSPD.h"
-#include "AliITSgeomSDD.h"
-#include "AliITSgeomSSD.h"
-#include "AliITSDetType.h"
-#include "AliITSresponseSPD.h"
-#include "AliITSresponseSDD.h"
-#include "AliITSresponseSSD.h"
-#include "AliITSsegmentationSPD.h"
+#include "AliITSCalibrationSDD.h"
 #include "AliITSsegmentationSDD.h"
+#include "AliITSsegmentationSPD.h"
 #include "AliITSsegmentationSSD.h"
-#include "AliITSsimulationSPD.h"
-#include "AliITSsimulationSDD.h"
-#include "AliITSsimulationSSD.h"
-#include "AliITSClusterFinderSPD.h"
-#include "AliITSClusterFinderSDD.h"
-#include "AliITSClusterFinderSSD.h"
-#include "AliITSBaseGeometry.h"
 #include "AliITSv11.h"
+#include "AliLog.h"
+#include "AliMC.h"
+#include "AliMagF.h"
+#include "AliRun.h"
+#include "AliTrackReference.h"
+#include "AliITSv11GeometrySPD.h"
+#include "AliITSv11GeometrySDD.h"
+#include "AliITSv11GeometrySSD.h"
+#include "AliITSv11GeometrySupport.h"
+#include "AliGeomManager.h"
 
-// Units, Convert from k?? to cm,degree,GeV,seconds,
-const Double_t kmm = 0.10; // Convert mm to TGeom's cm.
-const Double_t kcm = 1.00; // Convert cv to TGeom's cm.
-const Double_t kDegree = 1.0; // Convert degrees to TGeom's degrees
-const Double_t kRadian = TMath::DegToRad(); // conver to Radians
-
-#define SQ(A) ((A)*(A))
-
-#define printArb8(A)  if(GetDebug()){\
-   cout << A->GetName() << ":"; \
-  for(Int_t iii=0;iii<8;iii+=2){ cout <<"("<<A->GetVertices()[iii]<<","     \
-                          <<A->GetVertices()[iii+1]<<","<<-A->GetDz()<<")";}\
-  for(Int_t iii=8;iii<16;iii+=2){ cout <<"("<<A->GetVertices()[iii]<<","     \
-                          <<A->GetVertices()[iii+1]<<","<<A->GetDz()<<")";}\
-   cout << endl; }
-
-#define printPcon(A)  if(GetDebug()){\
-     cout << A->GetName() << ": N=" << A->GetNz() << " Phi1=" << A->GetPhi1() \
-          << ", Dphi=" << A->GetDphi() << endl;                              \
-     cout << "i\t   Z   \t  Rmin \t  Rmax" << endl;                          \
-     for(Int_t iii=0;iii<A->GetNz();iii++){                                 \
-         cout << iii << "\t" << A->GetZ(iii) << "\t" << A->GetRmin(iii)     \
-              << "\t" << A->GetRmax(iii) << endl;                           \
-     }} // end for iii
-
-#define printTube(A)  if(GetDebug()){\
-   cout << A->GetName() <<": Rmin="<<A->GetRmin()\
-                          <<" Rmax=" <<A->GetRmax()<<" Dz="<<A->GetDz()<<endl;}
-
-#define printTubeSeg(A)   if(GetDebug()){\
-    cout << A->GetName() <<": Phi1="<<A->GetPhi1()<< \
-                           " Phi2="<<A->GetPhi2()<<" Rmin="<<A->GetRmin()\
-                          <<" Rmax=" <<A->GetRmax()<<" Dz="<<A->GetDz()<<endl;}
-
-#define printConeSeg(A)   if(GetDebug()){\
-    cout << A->GetName() <<": Phi1="<<A->GetPhi1()<< \
-                         " Phi2="<<A->GetPhi2()<<" Rmin1="<<A->GetRmin1()\
-                       <<" Rmax1=" <<A->GetRmax1()<<" Rmin2="<<A->GetRmin2()\
-                       <<" Rmax2=" <<A->GetRmax2()<<" Dz="<<A->GetDz()<<endl;}
-
-#define printBBox(A)   if(GetDebug()){\
-    cout << A->GetName() <<": Dx="<<A->GetDX()<< \
-                           " Dy="<<A->GetDY()<<" Dz="<<A->GetDZ() <<endl;}
 
 ClassImp(AliITSv11)
 
-/*
-  Some temparary #define's used untill ROOT has addoppted the proper
-  Getter in it's classes.
-  These Below are for TGeoPcon functions.
-*/
-
 //______________________________________________________________________
-AliITSv11::AliITSv11() : AliITS() {
-    // Standard default constructor for the ITS version 11.
+AliITSv11::AliITSv11():
+  fByThick(kTRUE),
+  fIDMother(0),
+  fInitGeom(kv11),
+  fSPDgeom(0),
+  fSDDgeom(0),
+  fSSDgeom(0),
+  fSupgeom(0)
+ {
+    //    Standard default constructor
     // Inputs:
     //   none.
     // Outputs:
     //   none.
-    // Return
-    //   A default constructed AliITSv11 class.
-
-    //fITSV = 0;
-    //fcS = 0;
-//   fcD = 0;
-}
-//______________________________________________________________________
-AliITSv11::AliITSv11(const char *title) : AliITS("ITS", title){
-    // Standard constructor for the ITS version 11.
-    // Inputs:
-    //   const char *title  The title of for this geometry.
-    // Outputs:
+    // Return:
     //   none.
-    // Return
-    //   A Standard constructed AliITSv11 class.
-
-    //fITSV = 0;
-    //fcS = 0;
-//    fcD = 0;
 }
-//______________________________________________________________________
-AliITSv11::~AliITSv11() {
-    // Standard destructor for the ITS version 11.
-    // Inputs:
-    //   none.
-    // Outputs:
-    //   none.
-    // Return
-    //   none.
 
-//    if(fITSV!=0) delete fITSV;
-//    if(fcS!=0) delete fcS;
-//    if(fcD!=0) delete fcD;
-}
 //______________________________________________________________________
-AliITSv11::AliITSv11(const AliITSv11 &source) : AliITS(source){
-    //     Copy Constructor for ITS version 11.
+AliITSv11::AliITSv11(const char *title) 
+  : AliITS("ITS", title),
+    fByThick(kTRUE),
+    fIDMother(0),
+    fInitGeom(kv11),
+    fSPDgeom(0),
+    fSDDgeom(0),
+    fSSDgeom(0),
+    fSupgeom(0)
+{
+    //    Standard constructor for the v11 geometry.
     // Inputs:
-    //   AliITSv11 &source  class to be copied from.
+    //   const char * title  Arbitrary title
     // Outputs:
     //   none.
-    // Return
+    // Return:
     //   none.
+  Int_t i;
+  
+  fSPDgeom = new AliITSv11GeometrySPD();
+  fSDDgeom = new AliITSv11GeometrySDD(0);
+  fSSDgeom = new AliITSv11GeometrySSD();
+  fSupgeom = new AliITSv11GeometrySupport();
 
-    if(&source == this) return;
-    Error("Copy Constructor","Not allowed to copy AliITSv11");
-    return;
-}
-//______________________________________________________________________
-AliITSv11& AliITSv11::operator=(const AliITSv11 &source){
-    //    Assignment operator for the ITS version 11.
-    // Inputs:
-    //   AliITSv11 &source  class to be copied from.
-    // Outputs:
-    //   none.
-    // Return
-    //   none.
+  fIdN = 6;
+  fIdName = new TString[fIdN];
 
-    if(&source == this) return *this;
-    Error("= operator","Not allowed to copy AliITSv11");
-    return *this;
+  fIdName[0] = fSPDgeom->GetSenstiveVolumeName1();
+  fIdName[1] = fSPDgeom->GetSenstiveVolumeName2();
+
+  fIdName[2] = fSDDgeom->GetSenstiveVolumeName3();
+  fIdName[3] = fSDDgeom->GetSenstiveVolumeName4();
+  
+  fIdName[4] = fSSDgeom->GetSenstiveVolumeName5();
+  fIdName[5] = fSSDgeom->GetSenstiveVolumeName6();
+
+  fIdSens    = new Int_t[fIdN];
+  for(i=0;i<fIdN;i++) fIdSens[i] = 0;
+
+  SetDensityServicesByThickness();
+  
 }
+
 //______________________________________________________________________
-void AliITSv11::BuildGeometry(){
-    // This routine defines and Creates the geometry for version 11 of 
-    // the ITS for use in the simulation display routines. This is a 
-    // very simplified geometry for speed of viewing.
+AliITSv11::AliITSv11(const char *name, const char *title) 
+  : AliITS("ITS", title),
+    fByThick(kTRUE),
+    fIDMother(0),
+    fInitGeom(kv11),
+    fSPDgeom(0),
+    fSDDgeom(0),
+    fSSDgeom(0),
+    fSupgeom(0)
+{
+    //    Standard constructor for the v11 geometry.
     // Inputs:
-    //   none.
+    //   const char * name   Ignored, set to "ITS"
+    //   const char * title  Arbitrary title
     // Outputs:
     //   none.
-    // Return
+    // Return:
     //   none.
-    TVector3 t(0.0,0.0,0.0);
+  Int_t i;
+  
+  fSPDgeom = new AliITSv11GeometrySPD();
+  fSDDgeom = new AliITSv11GeometrySDD(0);
+  fSSDgeom = new AliITSv11GeometrySSD();
+  fSupgeom = new AliITSv11GeometrySupport();
+
+  fIdN = 6;
+  fIdName = new TString[fIdN];
 
-    //if(fITSV==0) fITSV = new AliITSGeometryITSV(this,"ALIC");
-    //if(fcS==0) fcS = new AliITSGeometrySSDCone(this,t,"TSV",1);
+  (void) name; // removes warning message
 
-    //fcS->BuildDisplayGeometry();
+  fIdName[0] = fSPDgeom->GetSenstiveVolumeName1();
+  fIdName[1] = fSPDgeom->GetSenstiveVolumeName2();
+
+  fIdName[2] = fSDDgeom->GetSenstiveVolumeName3();
+  fIdName[3] = fSDDgeom->GetSenstiveVolumeName4();
+
+  fIdName[4] = fSSDgeom->GetSenstiveVolumeName5();
+  fIdName[5] = fSSDgeom->GetSenstiveVolumeName6();
+
+  fIdSens    = new Int_t[fIdN];
+  for(i=0;i<fIdN;i++) fIdSens[i] = 0;
+
+  SetDensityServicesByThickness();
+  
 }
+
 //______________________________________________________________________
-void AliITSv11::CreateGeometry(){
-    // This routine defines and Creates the geometry for version 11 of 
-    // the ITS. The geometry is used by the particle trasport routines,
-    // and therefore, is very detailed.
+AliITSv11::~AliITSv11() {
+    //    Standard destructor
     // Inputs:
     //   none.
     // Outputs:
     //   none.
-    // Return
+    // Return:
     //   none.
-    TVector3 t(0.0,0.0,0.0);
-
-    TGeoManager *mgr = gGeoManager;
-    TGeoVolume *ALIC = mgr->GetTopVolume();
-
-    TGeoPcon *itsv = new TGeoPcon("ITS Top Volume, Daughter of ALIC",
-                                  0.0,360.0,2);
-    // DefineSection(section number, Z, Rmin, Rmax).
-    itsv->DefineSection(0,-300.0*kcm,0.01*kcm,50.0*kcm);
-    itsv->DefineSection(1,+300.0*kcm,0.01*kcm,50.0*kcm);
-    TGeoVolume *ITSV = new TGeoVolume("ITSV",itsv,0);
-    //mgr->AddVolume(ITSV);
-    ITSV->SetVisibility(kFALSE);
-    ALIC->AddNode(ITSV,1,0);
-    //
-    SPDCone(ITSV);
-    SDDCone(ITSV);
-    SSDCone(ITSV);
-    ServicesCableSupport(ITSV);
-}
-//______________________________________________________________________
-Double_t AliITSv11::RmaxFrom2Points(TGeoPcon *p,Int_t i1,Int_t i2,Double_t z){
-    // functions Require at parts of Volume A to be already defined.
-    // Retruns the value of Rmax corresponding to point z alone the line
-    // defined by the two points p.Rmax(i1),p-GetZ(i1) and p->GetRmax(i2),
-    // p->GetZ(i2).
-
-    return p->GetRmax(i2)+(p->GetRmax(i1)-p->GetRmax(i2))*(z-p->GetZ(i2))/
-     (p->GetZ(i1)-p->GetZ(i2));
+  delete fSPDgeom;
+  delete fSDDgeom;
+  delete fSSDgeom;
+  delete fSupgeom;
 }
-//______________________________________________________________________
-Double_t AliITSv11::RminFrom2Points(TGeoPcon *p,Int_t i1,Int_t i2,Double_t z){
-    // Retruns the value of Rmin corresponding to point z alone the line
-    // defined by the two points p->GetRmin(i1),p->GetZ(i1) and 
-    // p->GetRmin(i2),  p->GetZ(i2).
 
-    return p->GetRmin(i2)+(p->GetRmin(i1)-p->GetRmin(i2))*(z-p->GetZ(i2))/
-     (p->GetZ(i1)-p->GetZ(i2));
-}
 //______________________________________________________________________
-Double_t AliITSv11::RFrom2Points(Double_t *p,Double_t *Z,Int_t i1,
-                                 Int_t i2,Double_t z){
-    // Retruns the value of Rmin corresponding to point z alone the line
-    // defined by the two points p->GetRmin(i1),p->GetZ(i1) and 
-    // p->GetRmin(i2), p->GetZ(i2).
+void AliITSv11::SetT2Lmatrix(Int_t uid, Double_t yShift, 
+                            Bool_t yFlip, Bool_t yRot180) const
+{
 
-    return p[i2]+(p[i1]-p[i2])*(z-Z[i2])/(Z[i1]-Z[i2]);
-}
-//______________________________________________________________________
-Double_t AliITSv11::Zfrom2MinPoints(TGeoPcon *p,Int_t i1,Int_t i2,Double_t r){
-    // Retruns the value of Z corresponding to point R alone the line
-    // defined by the two points p->GetRmin(i1),p->GetZ(i1) and 
-    // p->GetRmin(i2),p->GetZ(i2)
+  //
+  // Creates the TGeo Local to Tracking transformation matrix
+  // and sends it to the corresponding TGeoPNEntry 
+  //
+  // This function is used in AddAlignableVolumes()
 
-    return p->GetZ(i2)+(p->GetZ(i1)-p->GetZ(i2))*(r-p->GetRmin(i2))/
-     (p->GetRmin(i1)-p->GetRmin(i2));
-}
-//______________________________________________________________________
-Double_t AliITSv11::Zfrom2MaxPoints(TGeoPcon *p,Int_t i1,Int_t i2,Double_t r){
-    // Retruns the value of Z corresponding to point R alone the line
-    // defined by the two points p->GetRmax(i1),p->GetZ(i1) and 
-    // p->GetRmax(i2),p->GetZ(i2)
+  TGeoPNEntry *alignableEntry = gGeoManager->GetAlignableEntryByUID(uid);
+  TGeoHMatrix* globMatrix = alignableEntry->GetGlobalOrig();
 
-    return p->GetZ(i2)+(p->GetZ(i1)-p->GetZ(i2))*(r-p->GetRmax(i2))/
-     (p->GetRmax(i1)-p->GetRmax(i2));
-}
-//______________________________________________________________________
-Double_t AliITSv11::Zfrom2Points(Double_t *Z,Double_t *p,Int_t i1,
-                                 Int_t i2,Double_t r){
-    // Retruns the value of Z corresponding to point R alone the line
-    // defined by the two points p->GetRmax(i1),p->GetZ(i1) and 
-    // p->GetRmax(i2),p->GetZ(i2)
+  Double_t *gtrans = globMatrix->GetTranslation(), rotMatrix[9];
+  memcpy(&rotMatrix[0], globMatrix->GetRotationMatrix(), 9*sizeof(Double_t));
+  Double_t al = TMath::ATan2(rotMatrix[1],rotMatrix[0]);
+  if (yRot180) {
+    al = TMath::ATan2(rotMatrix[1],-rotMatrix[0]);
+  }
+  Double_t xShift = gtrans[0]*TMath::Cos(al)+gtrans[1]*TMath::Sin(al);
+  Double_t zShift = -gtrans[2];
 
-    return Z[i2]+(Z[i1]-Z[i2])*(r-p[i2])/(p[i1]-p[i2]);
-}
-//______________________________________________________________________
-Double_t AliITSv11::RmaxFromZpCone(TGeoPcon *p,Double_t tc,Double_t z,
-                                   Double_t th){
-    // General SSD Outer Cone surface equation Rmax.
-    Double_t tantc = TMath::Tan(tc*TMath::DegToRad());
-    Double_t costc = TMath::Cos(tc*TMath::DegToRad());
+  TGeoHMatrix *matLtoT = new TGeoHMatrix;
+  matLtoT->SetDx( xShift ); // translation
+  matLtoT->SetDy( yShift );
+  matLtoT->SetDz( zShift );
+  rotMatrix[0]= 0;  rotMatrix[1]= 1;  rotMatrix[2]= 0; // + rotation
+  rotMatrix[3]= 1;  rotMatrix[4]= 0;  rotMatrix[5]= 0;
+  rotMatrix[6]= 0;  rotMatrix[7]= 0;  rotMatrix[8]=-1;
+  if (yFlip) rotMatrix[3] = -1;  // flipping in y  (for SPD1)
+  if (yFlip) rotMatrix[1] = -1;  // flipping in y  (for SPD1)
 
-    return -tantc*(z-p->GetZ(4))+p->GetRmax(4)+th/costc;
-}
-//______________________________________________________________________
-Double_t AliITSv11::RmaxFromZpCone(Double_t *GetRmax,Double_t *GetZ,
-                                   Double_t tc,Double_t z,Double_t th){
-    // General SSD Outer Cone surface equation Rmax.
-    Double_t tantc = TMath::Tan(tc*TMath::DegToRad());
-    Double_t costc = TMath::Cos(tc*TMath::DegToRad());
+  if (yRot180) { // rotation of pi around the axis perpendicular to the wafer
+    if (yFlip) matLtoT->SetDx( -xShift ); // flipping in y  (for SPD1)
+    matLtoT->SetDy( -yShift );
+    matLtoT->SetDz( -zShift );
+    rotMatrix[8]=1;
+    rotMatrix[3] = -1;
+    if (yFlip) rotMatrix[3] = 1;  // flipping in y  (for SPD1)
+  }
 
-    return -tantc*(z-GetZ[4])+GetRmax[4]+th/costc;
+  TGeoRotation rot;
+  rot.SetMatrix(rotMatrix);
+  matLtoT->MultiplyLeft(&rot);
+  TGeoHMatrix *matTtoL = new TGeoHMatrix(matLtoT->Inverse());
+  delete matLtoT;
+  alignableEntry->SetMatrix(matTtoL);
 }
-//______________________________________________________________________
-Double_t AliITSv11::RminFromZpCone(TGeoPcon *p,Double_t tc,Double_t z,
-                                   Double_t th){
-    // General SSD Inner Cone surface equation Rmin.
-    Double_t tantc = TMath::Tan(tc*TMath::DegToRad());
-    Double_t costc = TMath::Cos(tc*TMath::DegToRad());
 
-    return -tantc*(z-p->GetZ(3))+p->GetRmin(3)+th/costc;
-}
 //______________________________________________________________________
-Double_t AliITSv11::RminFromZpCone(Double_t *GetRmin,Double_t *GetZ,
-                                   Double_t tc,Double_t z,Double_t th){
-    // General SSD Inner Cone surface equation Rmin.
-    Double_t tantc = TMath::Tan(tc*TMath::DegToRad());
-    Double_t costc = TMath::Cos(tc*TMath::DegToRad());
+void AliITSv11::AddAlignableVolumes() const
+{
+  // Creates entries for alignable volumes associating the symbolic volume
+  // name with the corresponding volume path.
+  // 
+  // Records in the alignable entries the transformation matrices converting
+  // TGeo local coordinates (in the RS of alignable volumes) to the tracking
+  // system
+  // For this, this function has to run before the misalignment because we
+  // are using the ideal positions in the AliITSgeom object.
+  // Inputs:
+  //   none.
+  // Outputs:
+  //   none.
+  // Return:
+  //   none.
 
-    return -tantc*(z-GetZ[3])+GetRmin[3]+th/costc;
-}
-//______________________________________________________________________
-Double_t AliITSv11::ZFromRmaxpCone(TGeoPcon *p,Double_t tc,Double_t r,
-                                   Double_t th){
-    // General SSD Outer cone Surface equation for z.
-    Double_t tantc = TMath::Tan(tc*TMath::DegToRad());
-    Double_t costc = TMath::Cos(tc*TMath::DegToRad());
+  AliInfo("Add ITS alignable volumes");
 
-    return p->GetZ(4)+(p->GetRmax(4)+th/costc-r)/tantc;
-}
-//______________________________________________________________________
-Double_t AliITSv11::ZFromRmaxpCone(Double_t *GetRmax,Double_t *GetZ,
-                                   Double_t tc,Double_t r,Double_t th){
-    // General SSD Outer cone Surface equation for z.
-    Double_t tantc = TMath::Tan(tc*TMath::DegToRad());
-    Double_t costc = TMath::Cos(tc*TMath::DegToRad());
+  if (!gGeoManager) {
+    AliFatal("TGeoManager doesn't exist !");
+    return;
+  }
 
-    return GetZ[4]+(GetRmax[4]+th/costc-r)/tantc;
-}
-//______________________________________________________________________
-Double_t AliITSv11::ZFromRminpCone(TGeoPcon *p,Double_t tc,Double_t r,
-                                   Double_t th){
-    // General SSD Inner cone Surface equation for z.
-    Double_t tantc = TMath::Tan(tc*TMath::DegToRad());
-    Double_t costc = TMath::Cos(tc*TMath::DegToRad());
+  AliGeomManager::ELayerID layerId;
+  Int_t modUID, modnum;
+
+  if( !gGeoManager->SetAlignableEntry("ITS","ALIC_1/ITSV_1") )
+    AliFatal(Form("Unable to set alignable entry ! %s :: %s",
+                  "ITS","ALIC_1/ITSV_1"));    
+
+  TString strSPD = "ITS/SPD";
+  TString strSDD = "ITS/SDD";
+  TString strSSD = "ITS/SSD";
+  TString strStave = "/Stave";
+  TString strHalfStave = "/HalfStave";
+  TString strLadder = "/Ladder";
+  TString strSector = "/Sector";
+  TString strSensor = "/Sensor";
+  TString strEntryName1;
+  TString strEntryName2;
+  TString strEntryName3;
+  TString strEntryName4;
+
+  TString str0;
+  TString str1;
+  TString str2;
+
+  TString ladder;
+
+  //===== SPD layers =====
+  
+  str0 = "ALIC_1/ITSV_1/ITSSPD_1/ITSSPDCarbonFiberSectorV_";
+  str1 = "/ITSSPDSensitiveVirtualvolumeM0_1/ITSSPDlay1-Stave_";
+
+  TString str1Bis = "/ITSSPDhalf-Stave";
+  TString str1Tierce = "_1";
+
+  str2 = "/ITSSPDlay1-Ladder_";
+  
+  TString sector;
+  TString stave;
+  TString halfStave;
+  TString module;
+
+  layerId = AliGeomManager::kSPD1;
+  modnum = 0;
+    
+  for(Int_t cSect = 0; cSect<10; cSect++) {
+
+    sector = str0;
+    sector += cSect+1; // this is one full sector
+    strEntryName1 = strSPD;
+    strEntryName1 += 0;
+    strEntryName1 += strSector;
+    strEntryName1 += cSect;
+    if(!gGeoManager->SetAlignableEntry(strEntryName1.Data(),sector.Data()))
+      AliFatal(Form("New lay 1: Unable to set alignable entry 1! %s::%s",
+               strEntryName1.Data(),sector.Data()));
+
+    for(Int_t cStave=0; cStave<2; cStave++) {
+       
+      stave = sector;
+      stave += str1;
+      stave += cStave+1;
+      strEntryName2 = strEntryName1;
+      strEntryName2 += strStave;
+      strEntryName2 += cStave;
+
+      for(Int_t cHS=0; cHS<2; cHS++) {
+
+       halfStave = stave;
+       halfStave += str1Bis;
+       halfStave += cHS;
+       halfStave += str1Tierce;
+       strEntryName3 = strEntryName2;
+       strEntryName3 += strHalfStave;
+       strEntryName3 += cHS;
+
+       if(!gGeoManager->SetAlignableEntry(strEntryName3.Data(),
+                                          halfStave.Data()))
+         AliFatal(Form("New lay 1: Unable to set alignable entry 3! %s::%s",
+                       strEntryName3.Data(),halfStave.Data()));    
+
+       for(Int_t cLad=0; cLad<2; cLad++) {
+         
+         modUID = AliGeomManager::LayerToVolUID(layerId,modnum++);
+         module = halfStave;
+         module += str2;
+         module += cLad+cHS*2+1;
+         strEntryName4 = strEntryName3;
+         strEntryName4 += strLadder;
+         strEntryName4 += cLad+cHS*2;
+         if(!gGeoManager->SetAlignableEntry(strEntryName4.Data(),module.Data(),modUID))
+           AliFatal(Form("New lay 1: Unable to set alignable entry 4! %s::%s",
+                         strEntryName4.Data(),module.Data()));
+
+         SetT2Lmatrix(modUID, 0.0081, kTRUE, kTRUE);
+         // 0.0081 is the shift between the centers of alignable 
+         // and sensitive volumes. It is directly extracted from 
+         // the new SPD geometry
+       } // end for cLad
+      } // end for cHS
+    } // end for cStave
+  } // end for cSect
+
+  layerId = AliGeomManager::kSPD2;
+  modnum = 0;
+  str1 = "/ITSSPDSensitiveVirtualvolumeM0_1/ITSSPDlay2-Stave_";
+  str2 = "/ITSSPDlay2-Ladder_";
+
+  for(Int_t cSect = 0; cSect<10; cSect++) {
+
+    sector = str0;
+    sector += cSect+1; // this is one full sector
+    strEntryName1 = strSPD;
+    strEntryName1 += 1;
+    strEntryName1 += strSector;
+    strEntryName1 += cSect;
+      
+    for(Int_t cStave=0; cStave<4; cStave++) {
+       
+      stave = sector;
+      stave += str1;
+      stave += cStave+1;
+      strEntryName2 = strEntryName1;
+      strEntryName2 += strStave;
+      strEntryName2 += cStave;
+
+      for(Int_t cHS=0; cHS<2; cHS++) {
+
+       halfStave = stave;
+       halfStave += str1Bis;
+       halfStave += cHS;
+       halfStave += str1Tierce;
+       strEntryName3 = strEntryName2;
+       strEntryName3 += strHalfStave;
+       strEntryName3 += cHS;
+
+       if(!gGeoManager->SetAlignableEntry(strEntryName3.Data(),
+                                          halfStave.Data()))
+         AliFatal(Form("New lay 2: Unable to set alignable entry 3! %s::%s",
+                       strEntryName3.Data(),halfStave.Data()));    
+
+       for(Int_t cLad=0; cLad<2; cLad++) {
+
+         modUID = AliGeomManager::LayerToVolUID(layerId,modnum++);
+         module = halfStave;
+         module += str2;
+         module += cLad+cHS*2 +1;
+         strEntryName4 = strEntryName3;
+         strEntryName4 += strLadder;
+         strEntryName4 += cLad+cHS*2;
+         if(!gGeoManager->SetAlignableEntry(strEntryName4.Data(),module.Data(),modUID))
+           AliFatal(Form("New lay 2: Unable to set alignable entry 4! %s::%s",
+                         strEntryName4.Data(),module.Data()));
+
+         SetT2Lmatrix(modUID, -0.0081, kFALSE);
+       } // end for cLad
+      } // end for cHS
+    } // end for cStave
+  } // cSect
+
+  //===== SDD layers =====
+
+  layerId = AliGeomManager::kSDD1;
+  modnum = 0;
+
+  str0 = "/ALIC_1/ITSV_1/ITSsddLayer3_1/ITSsddLadd_"; // SDD layer1
+  str1 = "/ITSsddSensor3_";
+
+  TString sensor;
+
+  for(Int_t c1 = 0; c1<14; c1++) {
+
+    ladder = str0;
+    ladder += c1; // the set of wafers from one ladder
+    strEntryName1 = strSDD;
+    strEntryName1 += 2;
+    strEntryName1 +=strLadder;
+    strEntryName1 += c1;
+    //printf("%s    ==    %s\n",strEntryName1.Data(),ladder.Data());
+    if(!gGeoManager->SetAlignableEntry(strEntryName1.Data(),ladder.Data()))
+      AliFatal(Form("Unable to set alignable entry 1! %s :: %s",
+                   strEntryName1.Data(),ladder.Data()));
+
+    for(Int_t c2 =0; c2<6; c2++) {
 
-    return p->GetZ(3)+(p->GetRmin(3)+th/costc-r)/tantc;
+      modUID = AliGeomManager::LayerToVolUID(layerId,modnum++);
+      sensor = ladder;
+      sensor += str1;
+      sensor += c2;
+      strEntryName2 = strEntryName1;
+      strEntryName2 += strSensor;
+      strEntryName2 += c2;
+      //printf("%s    ==    %s\n",strEntryName2.Data(),wafer.Data());
+      if(!gGeoManager->SetAlignableEntry(strEntryName2.Data(),sensor.Data(),modUID))
+       AliFatal(Form("Unable to set alignable entry 2! %s :: %s",
+                     strEntryName2.Data(),sensor.Data()));
+
+      SetT2Lmatrix(modUID, 0, kFALSE, c2>=3);
+    }
+  }
+
+  layerId = AliGeomManager::kSDD2;
+  modnum = 0;
+  str0 = "/ALIC_1/ITSV_1/ITSsddLayer4_1/ITSsddLadd_"; // SDD layer2
+  str1 = "/ITSsddSensor4_";
+    
+  for(Int_t c1 = 0; c1<22; c1++) {
+
+    ladder = str0;
+    ladder += c1; // the set of wafers from one ladder
+    strEntryName1 = strSDD;
+    strEntryName1 += 3;
+    strEntryName1 += strLadder;
+    strEntryName1 += c1;
+    //printf("%s    ==    %s\n",strEntryName1.Data(),ladder.Data());
+    if(!gGeoManager->SetAlignableEntry(strEntryName1.Data(),ladder.Data()))
+      AliFatal(Form("Unable to set alignable entry 1! %s :: %s",
+                   strEntryName1.Data(),ladder.Data()));
+
+    for(Int_t c2 =0; c2<8; c2++) {
+
+      modUID = AliGeomManager::LayerToVolUID(layerId,modnum++);
+      sensor = ladder;
+      sensor += str1;
+      sensor += c2;
+      strEntryName2 = strEntryName1;
+      strEntryName2 += strSensor;
+      strEntryName2 += c2;
+      //printf("%s    ==    %s\n",strEntryName2.Data(),wafer.Data());
+      if(!gGeoManager->SetAlignableEntry(strEntryName2.Data(),sensor.Data(),modUID))
+       AliFatal(Form("Unable to set alignable entry 2! %s :: %s",
+                     strEntryName2.Data(),sensor.Data()));
+
+      SetT2Lmatrix(modUID, 0, kFALSE, c2>=4);
+    }
+  }
+
+  //===== SSD layers =====
+
+  layerId = AliGeomManager::kSSD1;
+  modnum = 0;
+
+  str0 = "/ALIC_1/ITSV_1/ITSssdLayer5_1/ITSssdLay5Ladd_";//SSD layer1
+  str1 = "/ITSssdSensor5_";
+  str2 = "";
+
+  TString wafer;
+
+  for(Int_t c1 = 0; c1<34; c1++) {
+
+    ladder = str0;
+    ladder += c1; // the set of wafers from one ladder
+    strEntryName1 = strSSD;
+    strEntryName1 += 4;
+    strEntryName1 += strLadder;
+    strEntryName1 += c1;
+    //printf("%s    ==    %s\n",strEntryName1.Data(),ladder.Data());
+    if(!gGeoManager->SetAlignableEntry(strEntryName1.Data(),ladder.Data()))
+      AliFatal(Form("Unable to set alignable entry 1! %s :: %s",
+                   strEntryName1.Data(),ladder.Data()));
+
+    for(Int_t c2 =0; c2<22; c2++) {
+
+      modUID = AliGeomManager::LayerToVolUID(layerId,modnum++);
+      wafer = ladder;
+      wafer += str1;
+      wafer += c2;
+      //wafer += str2;    // one wafer
+      strEntryName2 = strEntryName1;
+      strEntryName2 += strSensor;
+      strEntryName2 += c2;
+      //printf("%s    ==    %s\n",strEntryName2.Data(),wafer.Data());
+      if(!gGeoManager->SetAlignableEntry(strEntryName2.Data(),wafer.Data(),modUID))
+       AliFatal(Form("Unable to set alignable entry 2! %s :: %s",
+                     strEntryName2.Data(),wafer.Data()));
+
+      SetT2Lmatrix(modUID, 0, kFALSE, kFALSE);
+    }
+  }
+
+  layerId = AliGeomManager::kSSD2;
+  modnum = 0;
+  str0 = "/ALIC_1/ITSV_1/ITSssdLayer6_1/ITSssdLay6Ladd_"; // SSD layer2
+  str1 = "/ITSssdSensor6_";
+  str2 = "";
+  
+  for(Int_t c1 = 0; c1<38; c1++) {
+
+    ladder = str0;
+    ladder += c1; // the set of wafers from one ladder
+    strEntryName1 = strSSD;
+    strEntryName1 += 5;
+    strEntryName1 += strLadder;
+    strEntryName1 += c1;
+    //printf("%s    ==    %s\n",strEntryName1.Data(),ladder.Data());
+    if(!gGeoManager->SetAlignableEntry(strEntryName1.Data(),ladder.Data()))
+      AliFatal(Form("Unable to set alignable entry 1! %s :: %s",
+                   strEntryName1.Data(),ladder.Data()));
+
+    for(Int_t c2 =0; c2<25; c2++) {
+
+      modUID = AliGeomManager::LayerToVolUID(layerId,modnum++);
+      wafer = ladder;
+      wafer += str1;
+      wafer += c2;
+      //wafer += str2;    // one wafer
+      strEntryName2 = strEntryName1;
+      strEntryName2 += strSensor;
+      strEntryName2 += c2;
+      //printf("%s    ==    %s\n",strEntryName2.Data(),wafer.Data());
+      if(!gGeoManager->SetAlignableEntry(strEntryName2.Data(),wafer.Data(),modUID))
+       AliFatal(Form("Unable to set alignable entry 2! %s :: %s",
+                     strEntryName2.Data(),wafer.Data()));
+
+      SetT2Lmatrix(modUID, 0, kFALSE, kFALSE);
+    }
+  }
+    
 }
+
 //______________________________________________________________________
-void AliITSv11::RadiusOfCurvature(Double_t rc,Double_t theta0,Double_t z0,
-                 Double_t r0,Double_t theta1,Double_t &z1,
-                 Double_t &r1){
-    // Given a initial point z0,r0, the initial angle theta0, and the radius
-    // of curvature, returns the point z1, r1 at the angle theta1. Theta
-    // measured from the r axis in the clock wise direction [degrees].
-    Double_t sin0 = TMath::Sin(theta0*TMath::DegToRad());
-    Double_t cos0 = TMath::Cos(theta0*TMath::DegToRad());
-    Double_t sin1 = TMath::Sin(theta1*TMath::DegToRad());
-    Double_t cos1 = TMath::Cos(theta1*TMath::DegToRad());
-
-    z1 = rc*(sin1-sin0)+z0;
-    r1 = rc*(cos1-cos0)+r0;
-    return;
+void AliITSv11::CreateGeometry()
+{
+  // Create the geometry and insert it in ALIC
+
+  TGeoManager *geoManager = gGeoManager;
+
+  TGeoVolume *vALIC = geoManager->GetVolume("ALIC");
+
+  // This part is really ugly, needs to be redone
+  new TGeoVolumeAssembly("ITSV");
+  new TGeoVolumeAssembly("ITSS");
+
+  TGeoVolume *vITSV = geoManager->GetVolume("ITSV");
+  TGeoVolume *vITSS = geoManager->GetVolume("ITSS");
+
+  vALIC->AddNode(vITSV, 1, 0);
+  vALIC->AddNode(vITSS, 1, 0);
+
+  //
+  const Int_t kLength=100;
+  Char_t vstrng[kLength];
+  if(fInitGeom.WriteVersionString(vstrng,kLength,(AliITSVersion_t)IsVersion())){
+    vITSV->SetTitle(vstrng);
+    vITSS->SetTitle(vstrng);
+  }
+
+  fSPDgeom->SPDSector(vITSV);
+
+  fSDDgeom->Layer3(vITSV);
+  fSDDgeom->Layer4(vITSV);
+  fSDDgeom->ForwardLayer3(vITSV);
+  fSDDgeom->ForwardLayer4(vITSV);
+
+  fSSDgeom->Layer5(vITSV);
+  fSSDgeom->Layer6(vITSV);
+  fSSDgeom->LadderSupportLayer5(vITSV);
+  fSSDgeom->LadderSupportLayer6(vITSV);
+  fSSDgeom->EndCapSupportSystemLayer6(vITSV);
+  fSSDgeom->EndCapSupportSystemLayer5(vITSV);
+
+  fSupgeom->SPDCone(vITSV);
+  fSupgeom->SDDCone(vITSV);
+  fSupgeom->SSDCone(vITSV);
+
+  fSDDgeom->SDDCables(vITSV);
+  fSSDgeom->SSDCables(vITSV);
+  fSupgeom->ServicesCableSupport(vITSS);
+
+  fSupgeom->ITSTPCSupports(vITSS);
+
 }
+
 //______________________________________________________________________
-void AliITSv11::SPDCone(TGeoVolume *Moth){
-    // Define the detail SPD support cone geometry.
+void AliITSv11::CreateMaterials()
+{
+    // Create ITS materials
+    //     This function defines the default materials used in the Geant
+    // Monte Carlo simulations for the geometries AliITSv1, AliITSv3,
+    // AliITSv11.
+    // In general it is automatically replaced by
+    // the CreateMaterials routine defined in AliITSv?. Should the function
+    // CreateMaterials not exist for the geometry version you are using this
+    // one is used. See the definition found in AliITSv5 or the other routine
+    // for a complete definition.
     // Inputs:
     //   none.
     // Outputs:
-    //  none.
+    //   none.
     // Return:
-    //  none.
+    //   none.
+
+    Int_t   ifield = ((AliMagF*)TGeoGlobalMagField::Instance()->GetField())->Integ();
+    Float_t fieldm = ((AliMagF*)TGeoGlobalMagField::Instance()->GetField())->Max();
+
+    Float_t tmaxfd = 0.1; // 1.0; // Degree
+    Float_t stemax = 1.0; // cm
+    Float_t deemax = 0.1; // 30.0; // Fraction of particle's energy 0<deemax<=1
+    Float_t epsil  = 1.0E-4; // 1.0; // cm
+    Float_t stmin  = 0.0; // cm "Default value used"
+
+    Float_t tmaxfdSi = 0.1; // .10000E+01; // Degree
+    Float_t stemaxSi = 0.0075; //  .10000E+01; // cm
+    Float_t deemaxSi = 0.1; // 0.30000E-02; // Fraction of particle's energy 0<deemax<=1
+    Float_t epsilSi  = 1.0E-4;// .10000E+01;
+    Float_t stminSi  = 0.0; // cm "Default value used"
+
+    Float_t tmaxfdAir = 0.1; // .10000E+01; // Degree
+    Float_t stemaxAir = .10000E+01; // cm
+    Float_t deemaxAir = 0.1; // 0.30000E-02; // Fraction of particle's energy 0<deemax<=1
+    Float_t epsilAir  = 1.0E-4;// .10000E+01;
+    Float_t stminAir  = 0.0; // cm "Default value used"
+
+    Float_t tmaxfdServ = 1.0; // 10.0; // Degree
+    Float_t stemaxServ = 1.0; // 0.01; // cm
+    Float_t deemaxServ = 0.5; // 0.1; // Fraction of particle's energy 0<deemax<=1
+    Float_t epsilServ  = 1.0E-3; // 0.003; // cm
+    Float_t stminServ  = 0.0; //0.003; // cm "Default value used"
+
+    // Freon PerFluorobuthane C4F10 see 
+    // http://st-support-cooling-electronics.web.cern.ch/
+    //        st-support-cooling-electronics/default.htm
+    Float_t afre[2]  = { 12.011,18.9984032 };
+    Float_t zfre[2]  = { 6., 9. };
+    Float_t wfre[2]  = { 4.,10. };
+    Float_t densfre  = 1.52;
+
+
+    //CM55J
+
+    Float_t aCM55J[4]={12.0107,14.0067,15.9994,1.00794};
+    Float_t zCM55J[4]={6.,7.,8.,1.};
+    Float_t wCM55J[4]={0.908508078,0.010387573,0.055957585,0.025146765};
+    Float_t dCM55J = 1.8;
+
+    //ALCM55J
+
+    Float_t aALCM55J[5]={12.0107,14.0067,15.9994,1.00794,26.981538};
+    Float_t zALCM55J[5]={6.,7.,8.,1.,13.};
+    Float_t wALCM55J[5]={0.817657902,0.0093488157,0.0503618265,0.0226320885,0.1};
+    Float_t dALCM55J = 1.9866;
+
+    //Si Chips
+
+    Float_t aSICHIP[6]={12.0107,14.0067,15.9994,1.00794,28.0855,107.8682};
+    Float_t zSICHIP[6]={6.,7.,8.,1.,14., 47.};
+    Float_t wSICHIP[6]={0.039730642,0.001396798,0.01169634,0.004367771,0.844665,0.09814344903};
+    Float_t dSICHIP = 2.36436;
+
+    //Inox
+    
+    Float_t aINOX[9]={12.0107,54.9380, 28.0855,30.9738,32.066,58.6928,51.9961,95.94,55.845};
+    Float_t zINOX[9]={6.,25.,14.,15.,16., 28.,24.,42.,26.};
+    Float_t wINOX[9]={0.0003,0.02,0.01,0.00045,0.0003,0.12,0.17,0.025,0.654};
+    Float_t dINOX = 8.03;
+
+    //AISI 304 L (from F.Tosello's web page - M.S. 18 Oct 10)
+    
+    Float_t a304L[8]={12.0107,54.9380, 28.0855,30.9738,32.066,58.6928,51.9961,55.845};
+    Float_t z304L[8]={6.,25.,14.,15.,16., 28.,24.,26.};
+    Float_t w304L[8]={0.0003,0.02,0.01,0.00045,0.003,0.0925,0.19,0.6865};
+    Float_t d304L = 8.03;
+
+    //SDD HV microcable
+
+    Float_t aHVm[5]={12.0107,1.00794,14.0067,15.9994,26.981538};
+    Float_t zHVm[5]={6.,1.,7.,8.,13.};
+    Float_t wHVm[5]={0.520088819984,0.01983871336,0.0551367996,0.157399667056, 0.247536};
+    Float_t dHVm = 1.6087;
+
+    //SDD LV+signal cable
+
+    Float_t aLVm[5]={12.0107,1.00794,14.0067,15.9994,26.981538};
+    Float_t zLVm[5]={6.,1.,7.,8.,13.};
+    Float_t wLVm[5]={0.21722436468,0.0082859922,0.023028867,0.06574077612, 0.68572};
+    Float_t dLVm = 2.1035;
+
+    //SDD hybrid microcab
+
+    Float_t aHLVm[5]={12.0107,1.00794,14.0067,15.9994,26.981538};
+    Float_t zHLVm[5]={6.,1.,7.,8.,13.};
+    Float_t wHLVm[5]={0.24281879711,0.00926228815,0.02574224025,0.07348667449, 0.64869};
+    Float_t dHLVm = 2.0502;
+
+    //SDD anode microcab
+
+    Float_t aALVm[5]={12.0107,1.00794,14.0067,15.9994,26.981538};
+    Float_t zALVm[5]={6.,1.,7.,8.,13.};
+    Float_t wALVm[5]={0.392653705471,0.0128595919215,0.041626868025,0.118832707289, 0.431909};
+    Float_t dALVm = 2.0502;
+
+    //X7R capacitors - updated from F.Tosello's web page - M.S. 18 Oct 10
+
+    Float_t aX7R[6]={137.327,47.867,15.9994,58.6928,63.5460,118.710};
+    Float_t zX7R[6]={56.,22.,8.,28.,29.,50.};
+    Float_t wX7R[6]={0.524732,0.176736,0.179282,0.079750,0.019750,0.019750};
+    Float_t dX7R = 6.07914;
+
+    //X7R weld, i.e. Sn 60% Pb 40% (from F.Tosello's web page - M.S. 15 Oct 10)
+
+    Float_t aX7Rweld[2]={118.71 , 207.20};
+    Float_t zX7Rweld[2]={ 50.   ,  82.  };
+    Float_t wX7Rweld[2]={  0.60 ,   0.40};
+    Float_t dX7Rweld   = 8.52358;
+
+    // AIR
+
+    Float_t aAir[4]={12.0107,14.0067,15.9994,39.948};
+    Float_t zAir[4]={6.,7.,8.,18.};
+    Float_t wAir[4]={0.000124,0.755267,0.231781,0.012827};
+    Float_t dAir = 1.20479E-3;
+
+    // Water
+
+    Float_t aWater[2]={1.00794,15.9994};
+    Float_t zWater[2]={1.,8.};
+    Float_t wWater[2]={0.111894,0.888106};
+    Float_t dWater   = 1.0;
+
+    // CERAMICS
+  //     94.4% Al2O3 , 2.8% SiO2 , 2.3% MnO , 0.5% Cr2O3
+    Float_t acer[5]  = { 26.981539,15.9994,28.0855,54.93805,51.9961 };
+    Float_t zcer[5]  = {       13.,     8.,    14.,     25.,    24. };
+    Float_t wcer[5]  = {.4443408,.5213375,.0130872,.0178135,.003421};
+    Float_t denscer  = 3.6;
+
+    //G10FR4
+
+    Float_t zG10FR4[14] = {14.00,      20.00,  13.00,  12.00,  5.00,   22.00,  11.00,  19.00,  26.00,  9.00,   8.00,   6.00,   7.00,   1.00};
+    Float_t aG10FR4[14] = {28.0855000,40.0780000,26.9815380,24.3050000,10.8110000,47.8670000,22.9897700,39.0983000,55.8450000,18.9984000,15.9994000,12.0107000,14.0067000,1.0079400};
+    Float_t wG10FR4[14] = {0.15144894,0.08147477,0.04128158,0.00904554,0.01397570,0.00287685,0.00445114,0.00498089,0.00209828,0.00420000,0.36043788,0.27529426,0.01415852,0.03427566};
+    Float_t densG10FR4= 1.8;
+    
+     //--- EPOXY  --- C18 H19 O3
+      Float_t aEpoxy[3] = {15.9994, 1.00794, 12.0107} ; 
+      Float_t zEpoxy[3] = {     8.,      1.,      6.} ; 
+      Float_t wEpoxy[3] = {     3.,     19.,     18.} ; 
+      Float_t dEpoxy = 1.8 ;
+
+      // rohacell: C9 H13 N1 O2
+    Float_t arohac[4] = {12.01,  1.01, 14.010, 16.};
+    Float_t zrohac[4] = { 6.,    1.,    7.,     8.};
+    Float_t wrohac[4] = { 14.,   10.,    2.,     6.};
+    Float_t drohac    = 0.058;
+
+    // If he/she means stainless steel (inox) + Aluminium and Zeff=15.3383 then
+//
+// %Al=81.6164 %inox=100-%Al
+
+    Float_t aInAl[5] = {27., 55.847,51.9961,58.6934,28.0855 };
+    Float_t zInAl[5] = {13., 26.,24.,28.,14. };
+    Float_t wInAl[5] = {.816164, .131443,.0330906,.0183836,.000919182};
+    Float_t dInAl    = 3.075;
+
+    // Aluminum alloy with 12% Copper - 21 Oct 10
+
+    Float_t aAlCu12[2] = {26.9815, 63.546};
+    Float_t zAlCu12[2] = {13.    , 29.   };
+    Float_t wAlCu12[2] = { 0.88  ,  0.12 };
+    Float_t dAlCu12    = 2.96;
+
+    // Kapton
+
+    Float_t aKapton[4]={1.00794,12.0107, 14.010,15.9994};
+    Float_t zKapton[4]={1.,6.,7.,8.};
+    Float_t wKapton[4]={0.026362,0.69113,0.07327,0.209235};
+    Float_t dKapton   = 1.42;
+    
+    // Kapton + Cu (for Pixel Bus)
+
+    Float_t aKaptonCu[5]={1.00794, 12.0107, 14.010, 15.9994, 63.5460};
+    Float_t zKaptonCu[5]={1., 6., 7., 8., 29.};
+    Float_t wKaptonCuBus[5];
+    
+    // Kapton + Cu (for Pixel MCM)
+
+    Float_t wKaptonCuMCM[5];
+    
+    // Kapton + Cu (mix of two above)
+
+    Float_t wKaptonCuMix[5];
+
+    //SDD ruby sph.
+    Float_t aAlOxide[2]  = { 26.981539,15.9994};
+    Float_t zAlOxide[2]  = {       13.,     8.};
+    Float_t wAlOxide[2]  = {0.4707, 0.5293};
+    Float_t dAlOxide     = 3.97;
+
+    // Silica for optical fibers: Si O2
+    Float_t aoptfib[2] = { 28.0855, 15.9994};
+    Float_t zoptfib[2] = { 14.,      8.    };
+    Float_t woptfib[2] = {  1.,      2.    };
+    Float_t doptfib    = 2.55;
+
+    // Tetrafluorethylene-Perfluorpropylene (FEP) - 08 Mar 10
+    Float_t aFEP[2] = { 12.0107, 18.9984};
+    Float_t zFEP[2] = {  6.    ,  9.    };
+    Float_t wFEP[2] = {  1.    ,  2.    };
+    Float_t dFEP    = 2.15;
+
+    // PVC (C2H3Cl)n - 08 Jul 10
+    Float_t aPVC[3] = { 12.0107, 1.00794, 35.4527};
+    Float_t zPVC[3] = {  6.    , 1.     , 35.   };
+    Float_t wPVC[3] = {  2.    , 3.     ,  1.   };
+    Float_t dPVC    = 1.3;
+
+    // PBT (Polybutylene terephthalate = C12-H12-O4) - 01 Sep 10
+    Float_t aPBT[3] = { 12.0107, 1.00794, 15.9994};
+    Float_t zPBT[3] = {  6.    , 1.     ,  8.   };
+    Float_t wPBT[3] = { 12.    ,12.     ,  4.   };
+    Float_t dPBT    = 1.31;
+
+    // POLYAX (POLYAX = C37-H24-O6-N2) - 03 Sep 10
+    Float_t aPOLYAX[4] = { 12.0107, 1.00794, 15.9994, 14.00674};
+    Float_t zPOLYAX[4] = {  6.    , 1.     ,  8.    ,  7.     };
+    Float_t wPOLYAX[4] = { 37.    ,24.     ,  6.    ,  2.     };
+    Float_t dPOLYAX    = 1.27;
+
+    // PPS (PPS = C6-H4-S) - 05 Sep 10
+    Float_t aPPS[3] = { 12.0107, 1.00794, 32.066};
+    Float_t zPPS[3] = {  6.    , 1.     , 16.   };
+    Float_t wPPS[3] = {  6.    , 4.     ,  1.   };
+    Float_t dPPS    = 1.35;
+
+    // Megolon (Polyolefin = (C-H2)n) - 20 Oct 10
+    Float_t aMegolon[2] = { 12.0107, 1.00794};
+    Float_t zMegolon[2] = {  6.    , 1.     };
+    Float_t wMegolon[2] = {  1.    , 2.     };
+    Float_t dMegolon    = 1.51; // Mean of various types
+
+    // Standard glass (from glassproperties.com/glasses - M.S. 21 Oct 10)
+    Float_t aStdGlass[7] = {15.9994  ,28.0855  ,22.98977 ,40.078   ,
+                           24.305   ,26.981539,39.0983  };
+    Float_t zStdGlass[7] = { 8.      ,14.      ,11.      ,20.      ,
+                           12.      ,13.      ,19.      };
+    Float_t wStdGlass[7] = { 0.468377, 0.348239, 0.096441, 0.071469,
+                            0.006030, 0.005293, 0.004151};
+    Float_t dStdGlass    = 2.53;
+
+    // Glass Fiber (from F.Tosello's web page - M.S. 15 Oct 10)
+    Float_t aGlass[11] = {15.9994  ,28.0855  ,40.078   ,26.981539,10.811   ,
+               24.305   ,39.0983  ,22.98977 ,18.9984  ,47.867   ,55.845};
+    Float_t zGlass[11] = { 8.      ,14.      ,20       ,13       , 5       ,
+               12.      ,19       ,11       , 9       ,22       ,26    };
+    Float_t wGlass[11] = { 0.473610, 0.252415, 0.135791, 0.068803, 0.023293,
+                0.015076, 0.008301, 0.007419, 0.007000, 0.004795, 0.003497};
+    Float_t dGlass = 2.61;
+
+    // Ryton R-4 04 (from F.Tosello's web page - M.S. 15 Oct 10)
+    Float_t aRyton[14] = {15.9994  ,28.0855  ,40.078   ,26.981539,10.811   ,
+                         24.305   ,39.0983  ,22.98977 ,18.9984  ,47.867   ,
+                         55.845   ,12.0107  , 1.00794 ,32.066   };
+    Float_t zRyton[14] = { 8.      ,14.      ,20.      ,13.      , 5.      ,
+                         12.      ,19.      ,11.      , 9.      ,22.      ,
+                         26.      , 6.      , 1.      ,16.      };
+    Float_t wRyton[14] = { 0.189445, 0.100966, 0.054316, 0.027521, 0.009317,
+                          0.006030, 0.003320, 0.002968, 0.002800, 0.001918,
+                          0.001399, 0.399760, 0.022365, 0.177875};
+    Float_t dRyton = 1.65;
+
+    // Plexiglas (Poly(methyl methacrylate) (C5O2H8)n - M.S. 05 nov 10)
+    Float_t aPlexy[3] = { 12.0107, 15.9994,  1.00794};
+    Float_t zPlexy[3] = {  6.    , 8.     ,  1.   };
+    Float_t wPlexy[3] = {  5.    , 2.     ,  8.   };
+    Float_t dPlexy    = 1.18;
+
+    //SSD NiSn capacitor ends
+    Float_t aNiSn[2]  = { 56.6934,118.710};
+    Float_t zNiSn[2]  = {     28.,     50.};
+    Float_t wNiSn[2]  = {0.33, 0.67};
+    Float_t dNiSn     = wNiSn[0]*8.908 + wNiSn[1]*7.310;
+
+    // SPD cooling capillaries (Phynox)
+    Float_t aPhynox[5] = { 55.8450, 58.9332, 51.9961, 58.6934, 95.94 };
+    Float_t zPhynox[5] = { 26.    , 27.    , 24.    , 28.    , 42.   };
+    Float_t wPhynox[5] = { 0.17   , 0.40   , 0.20   , 0.16   , 0.07  };
+    Float_t dPhynox    = 8.3;
+
+    AliMaterial(1,"SI$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(1,"SI$",1,0,ifield,fieldm,tmaxfdSi,stemaxSi,deemaxSi,epsilSi,stminSi);
+
+    AliMaterial(2,"SPD SI CHIP$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(2,"SPD SI CHIP$",2,0,ifield,fieldm,tmaxfdSi,stemaxSi,deemaxSi,epsilSi,stminSi);
+
+    AliMaterial(3,"SPD SI BUS$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(3,"SPD SI BUS$",3,0,ifield,fieldm,tmaxfdSi,stemaxSi,deemaxSi,epsilSi,stminSi);
+
+    AliMixture(4,"C (M55J)$",aCM55J,zCM55J,dCM55J,4,wCM55J);
+    AliMedium(4,"C (M55J)$",4,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(5,"AIR$",aAir,zAir,dAir,4,wAir);
+    AliMedium(5,"AIR$",5,0,ifield,fieldm,tmaxfdAir,stemaxAir,deemaxAir,epsilAir,stminAir);
+
+    AliMixture(6,"GEN AIR$",aAir,zAir,dAir,4,wAir);
+    AliMedium(6,"GEN AIR$",6,0,ifield,fieldm,tmaxfdAir,stemaxAir,deemaxAir,epsilAir,stminAir);
+
+    AliMixture(7,"SDD SI CHIP$",aSICHIP,zSICHIP,dSICHIP,6,wSICHIP);
+    AliMedium(7,"SDD SI CHIP$",7,0,ifield,fieldm,tmaxfdSi,stemaxSi,deemaxSi,epsilSi,stminSi);
+
+    AliMixture(8,"PHYNOX$",aPhynox,zPhynox,dPhynox,5,wPhynox);
+    AliMedium(8,"PHYNOX$",8,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(9,"SDD C (M55J)$",aCM55J,zCM55J,dCM55J,4,wCM55J);
+    AliMedium(9,"SDD C (M55J)$",9,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(10,"SDD AIR$",aAir,zAir,dAir,4,wAir);
+    AliMedium(10,"SDD AIR$",10,0,ifield,fieldm,tmaxfdAir,stemaxAir,deemaxAir,epsilAir,stminAir);
+
+    AliMaterial(11,"AL$",0.26982E+02,0.13000E+02,0.26989E+01,0.89000E+01,0.99900E+03);
+    AliMedium(11,"AL$",11,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(12, "Water$",aWater,zWater,dWater,2,wWater);
+    AliMedium(12,"WATER$",12,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(13,"Freon$",afre,zfre,densfre,-2,wfre);
+    AliMedium(13,"Freon$",13,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(14,"COPPER$",0.63546E+02,0.29000E+02,0.89600E+01,0.14300E+01,0.99900E+03);
+    AliMedium(14,"COPPER$",14,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+    AliMixture(15,"CERAMICS$",acer,zcer,denscer,5,wcer);
+    AliMedium(15,"CERAMICS$",15,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(20,"SSD C (M55J)$",aCM55J,zCM55J,dCM55J,4,wCM55J);
+    AliMedium(20,"SSD C (M55J)$",20,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(21,"SSD AIR$",aAir,zAir,dAir,4,wAir);
+    AliMedium(21,"SSD AIR$",21,0,ifield,fieldm,tmaxfdAir,stemaxAir,deemaxAir,epsilAir,stminAir);
+
+    AliMixture(25,"G10FR4$",aG10FR4,zG10FR4,densG10FR4,14,wG10FR4);
+    AliMedium(25,"G10FR4$",25,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+     AliMixture(26,"GEN C (M55J)$",aCM55J,zCM55J,dCM55J,4,wCM55J);
+    AliMedium(26,"GEN C (M55J)$",26,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(27,"GEN Air$",aAir,zAir,dAir,4,wAir);
+    AliMedium(27,"GEN Air$",27,0,ifield,fieldm,tmaxfdAir,stemaxAir,deemaxAir,epsilAir,stminAir);
+
+    AliMixture(35,"PLEXYGLAS$",aPlexy,zPlexy,dPlexy,-3,wPlexy);
+    AliMedium(35,"PLEXYGLAS$",35,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(36,"STDGLASS$",aStdGlass,zStdGlass,dStdGlass,7,wStdGlass);
+    AliMedium(36,"STDGLASS$",36,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(37,"ALCU12$",aAlCu12,zAlCu12,dAlCu12,2,wAlCu12);
+    AliMedium(37,"ALCU12$",37,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(38,"MEGOLON$",aMegolon,zMegolon,dMegolon,-2,wMegolon);
+    AliMedium(38,"MEGOLON$",38,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(39,"RYTON$",aRyton,zRyton,dRyton,14,wRyton);
+    AliMedium(39,"RYTON$",39,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(40,"GLASS FIBER$",aGlass,zGlass,dGlass,11,wGlass);
+    AliMedium(40,"GLASS FIBER$",40,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(41,"AISI304L$",a304L,z304L,d304L,8,w304L);
+    AliMedium(41,"AISI304L$",41,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(42,"NICKEL$",0.58693E+02,0.28000E+02,0.89080E+01,0.14200E+01,0.99900E+03);
+    AliMedium(42,"NICKEL$",42,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+               
+    AliMixture(43,"SDD X7R weld$",aX7Rweld,zX7Rweld,dX7Rweld,2,wX7Rweld);
+    AliMedium(43,"SDD X7R weld$",43,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(44,"PPS$",aPPS,zPPS,dPPS,-3,wPPS);
+    AliMedium(44,"PPS$",44,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(45,"POLYAX$",aPOLYAX,zPOLYAX,dPOLYAX,-4,wPOLYAX);
+    AliMedium(45,"POLYAX$",45,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(46,"PBT$",aPBT,zPBT,dPBT,-3,wPBT);
+    AliMedium(46,"PBT$",46,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(47,"PVC$",aPVC,zPVC,dPVC,-3,wPVC);
+    AliMedium(47,"PVC$",47,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    Double_t cuFrac = 0.56;
+    Double_t kFrac  = 1.0 - cuFrac;
+    Double_t cuDens = 8.96;
+    Float_t dKaptonCuBus   = cuFrac * cuDens + kFrac * dKapton;
+    for (Int_t j=0; j<4; j++)
+      wKaptonCuBus[j] = wKapton[j]*kFrac;
+    wKaptonCuBus[4] = cuFrac;
+    AliMixture(48, "SPD-BUS CU KAPTON", aKaptonCu, zKaptonCu, dKaptonCuBus, 5, wKaptonCuBus);
+    AliMedium(48,"SPD-BUS CU KAPTON$",48,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+    
+    cuFrac = 0.5;
+    kFrac  = 1.0 - cuFrac;
+    Float_t dKaptonCuMCM   = cuFrac * cuDens + kFrac * dKapton;
+    for (Int_t j=0; j<4; j++)
+      wKaptonCuMCM[j] = wKapton[j]*kFrac;
+    wKaptonCuMCM[4] = cuFrac;
+    AliMixture(49, "SPD-MCM CU KAPTON", aKaptonCu, zKaptonCu, dKaptonCuMCM, 5, wKaptonCuMCM);
+    AliMedium(49,"SPD-MCM CU KAPTON$",49,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+    
+    cuFrac = (0.56 + 0.5) / 2.0;
+    kFrac  = 1.0 - cuFrac;
+    Float_t dKaptonCuMix   = cuFrac * cuDens + kFrac * dKapton;
+    for (Int_t j=0; j<4; j++)
+      wKaptonCuMix[j] = wKapton[j]*kFrac;
+    wKaptonCuMix[4] = cuFrac;
+    AliMixture(50, "SPD-MIX CU KAPTON", aKaptonCu, zKaptonCu, dKaptonCuMix, 5, wKaptonCuMix);
+    AliMedium(50,"SPD-MIX CU KAPTON$",50,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(51,"SPD SI$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(51,"SPD SI$",51,0,ifield,fieldm,tmaxfdSi,stemaxSi,deemaxSi,epsilSi,stminSi);
+
+    AliMaterial(52,"SPD SI CHIP$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(52,"SPD SI CHIP$",52,0,ifield,fieldm,tmaxfdSi,stemaxSi,deemaxSi,epsilSi,stminSi);
+
+    AliMaterial(53,"SPD SI BUS$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(53,"SPD SI BUS$",53,0,ifield,fieldm,tmaxfdSi,stemaxSi,deemaxSi,epsilSi,stminSi);
+
+    AliMixture(54,"SPD C (M55J)$",aCM55J,zCM55J,dCM55J,4,wCM55J);
+    AliMedium(54,"SPD C (M55J)$",54,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(55,"SPD AIR$",aAir,zAir,dAir,4,wAir);
+    AliMedium(55,"SPD AIR$",55,0,ifield,fieldm,tmaxfdAir,stemaxAir,deemaxAir,epsilAir,stminAir);
+
+    AliMixture(56, "SPD KAPTON(POLYCH2)", aKapton, zKapton, dKapton, 4, wKapton);
+    AliMedium(56,"SPD KAPTON(POLYCH2)$",56,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    // Gaseous Freon has same chemical composition but air density at 1.7 atm
+    AliMixture(59,"GASEOUS FREON$",afre,zfre,1.7*dAir,-2,wfre);
+    AliMedium(59,"GASEOUS FREON$",59,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(61,"EPOXY$",aEpoxy,zEpoxy,dEpoxy,-3,wEpoxy);
+    AliMedium(61,"EPOXY$",61,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(62,"SILICON$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(62,"SILICON$",62,0,ifield,fieldm,tmaxfdSi,stemaxSi,deemaxSi,epsilSi,stminSi);
+
+    AliMixture(63, "KAPTONH(POLYCH2)", aKapton, zKapton, dKapton, 4, wKapton);
+    AliMedium(63,"KAPTONH(POLYCH2)$",63,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(64,"ALUMINUM$",0.26982E+02,0.13000E+02,0.26989E+01,0.89000E+01,0.99900E+03);
+    AliMedium(64,"ALUMINUM$",64,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(65,"INOX$",aINOX,zINOX,dINOX,9,wINOX);
+    AliMedium(65,"INOX$",65,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(66,"NiSn$",aNiSn,zNiSn,dNiSn,2,wNiSn);
+    AliMedium(66,"NiSn$",66,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(67,"Sn$", 118.710, 50., 7.310, 1.206, 999.);
+    AliMedium(67,"Sn$",67,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(68,"ROHACELL$",arohac,zrohac,drohac,-4,wrohac);
+    AliMedium(68,"ROHACELL$",68,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+     AliMixture(69,"SDD C AL (M55J)$",aALCM55J,zALCM55J,dALCM55J,5,wALCM55J);
+    AliMedium(69,"SDD C AL (M55J)$",69,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+  
+    AliMixture(70, "SDDKAPTON (POLYCH2)", aKapton, zKapton, dKapton, 4, wKapton);
+    AliMedium(70,"SDDKAPTON (POLYCH2)$",70,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+     AliMaterial(71,"ITS SANDW A$",0.12011E+02,0.60000E+01,0.2115E+00,0.17479E+03,0.99900E+03);
+    AliMedium(71,"ITS SANDW A$",71,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(72,"ITS SANDW B$",0.12011E+02,0.60000E+01,0.27000E+00,0.18956E+03,0.99900E+03);
+    AliMedium(72,"ITS SANDW B$",72,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(73,"ITS SANDW C$",0.12011E+02,0.60000E+01,0.41000E+00,0.90868E+02,0.99900E+03);
+    AliMedium(73,"ITS SANDW C$",73,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(74,"HEAT COND GLUE$",0.12011E+02,0.60000E+01,0.1930E+01,0.22100E+02,0.99900E+03);
+    AliMedium(74,"HEAT COND GLUE$",74,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(75,"ELASTO SIL$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(75,"ELASTO SIL$",75,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    // SPD bus (data from Petra Riedler)
+    Float_t aSPDbus[5] = {1.00794,12.0107,14.01,15.9994,26.982 };
+    Float_t zSPDbus[5] = {1.,6.,7.,8.,13.};
+    Float_t wSPDbus[5] = {0.023523,0.318053,0.009776,0.078057,0.570591};
+    Float_t dSPDbus    = 2.128505;
+
+    //   AliMaterial(76,"SPDBUS(AL+KPT+EPOX)$",0.19509E+02,0.96502E+01,0.19060E+01,0.15413E+02,0.99900E+03);
+    AliMixture(76,"SPDBUS(AL+KPT+EPOX)$",aSPDbus,zSPDbus,dSPDbus,5,wSPDbus);
+    AliMedium(76,"SPDBUS(AL+KPT+EPOX)$",76,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+               
+    AliMixture(77,"SDD X7R capacitors$",aX7R,zX7R,dX7R,6,wX7R);
+    AliMedium(77,"SDD X7R capacitors$",77,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(78,"SDD ruby sph. Al2O3$",aAlOxide,zAlOxide,dAlOxide,2,wAlOxide);
+    AliMedium(78,"SDD ruby sph. Al2O3$",78,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMaterial(79,"SDD SI insensitive$",0.28086E+02,0.14000E+02,0.23300E+01,0.93600E+01,0.99900E+03);
+    AliMedium(79,"SDD SI insensitive$",79,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(80,"SDD HV microcable$",aHVm,zHVm,dHVm,5,wHVm);
+    AliMedium(80,"SDD HV microcable$",80,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(81,"SDD LV+signal cable$",aLVm,zLVm,dLVm,5,wLVm);
+    AliMedium(81,"SDD LV+signal cable$",81,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(82,"SDD hybrid microcab$",aHLVm, zHLVm,dHLVm,5,wHLVm);
+    AliMedium(82,"SDD hybrid microcab$",82,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(83,"SDD anode microcab$",aALVm,zALVm,dALVm,5,wALVm);
+    AliMedium(83,"SDD anode microcab$",83,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+    Float_t aDSring[4]={12.0107,      1.00794,     14.0067,      15.9994};
+    Float_t zDSring[4]={ 6.,          1.,           7.,           8.};
+    Float_t wDSring[4]={ 0.854323888, 0.026408778,  0.023050265,  0.096217069};
+    Float_t dDSring = 0.2875;
+    AliMixture(84,"SDD/SSD rings$",aDSring,zDSring,dDSring,4,wDSring);
+    AliMedium(84,"SDD/SSD rings$",84,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(85,"inox/alum$",aInAl,zInAl,dInAl,5,wInAl);
+    AliMedium(85,"inox/alum$",85,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    // special media to take into account services in the SDD and SSD 
+    // cones for the FMD
+    //Begin_Html
+    /*
+      <A HREF="http://www.Physics.ohio-state.edu/~nilsen/ITS/ITS_MatBudget_4B.xls">
+      </pre>
+      <br clear=left>
+      <font size=+2 color=blue>
+      <p> The Exel spread sheet from which these density number come from.
+      </font></A>
+    */
+    //End_Html
+
+    //  AliMaterial(86,"AIRFMDSDD$",0.14610E+02,0.73000E+01,0.12050E-02,0.30423E+05,0.99900E+03);
+    Float_t aA[13],zZ[13],wW[13],den;
+    // From Pierluigi Barberis calculations of 2SPD+1SDD October 2 2002.
+    zZ[0] = 1.0; aA[0] = 1.00794; // Hydrogen
+    zZ[1] = 6.0; aA[1] = 12.011; // Carbon
+    zZ[2] = 7.0; aA[2] = 14.00674; // Nitrogen
+    zZ[3] = 8.0; aA[3] = 15.9994; // Oxigen
+    zZ[4] = 14.0; aA[4] = 28.0855; // Silicon
+    zZ[5] = 24.0; aA[5] = 51.9961; //Cromium
+    zZ[6] = 25.0; aA[6] = 54.938049; // Manganese
+    zZ[7] = 26.0; aA[7] = 55.845; // Iron
+    zZ[8] = 28.0; aA[8] = 58.6934; // Nickle
+    zZ[9] = 29.0; aA[9] = 63.546; // Copper
+    zZ[10] = 13.0; aA[10] = 26.981539; // Alulminum
+    zZ[11] = 47.0; aA[11] = 107.8682; // Silver
+    zZ[12] = 27.0; aA[12] = 58.9332; // Cobolt
+    wW[0] = 0.019965;
+    wW[1] = 0.340961;
+    wW[2] = 0.041225;
+    wW[3] = 0.200352;
+    wW[4] = 0.000386;
+    wW[5] = 0.001467;
+    wW[6] = 0.000155;
+    wW[7] = 0.005113;
+    wW[8] = 0.000993;
+    wW[9] = 0.381262;
+    wW[10] = 0.008121;
+    wW[11] = 0.000000;
+    wW[12] = 0.000000;
+    if(fByThick){// New values seeITS_MatBudget_4B.xls
+       den = 1.5253276; // g/cm^3  Cell O370
+    }else{
+       den = 2.58423412; // g/cm^3 Cell L370
+    } // end if fByThick
+    //den = 6161.7/(3671.58978);//g/cm^3 Volume does not exclude holes
+    AliMixture(86,"AIRFMDSDD$",aA,zZ,den,+11,wW);
+    AliMedium(86,"AIRFMDSDD$",86,0,ifield,fieldm,tmaxfdAir,stemaxAir,
+             deemaxAir,epsilAir,stminAir);
+
+    //AliMaterial(87,"AIRFMDSSD$",0.14610E+02,0.73000E+01,0.12050E-02,0.30423E+05,0.99900E+03);
+    // From Pierluigi Barberis calculations of SSD October 2 2002.
+    wW[0] = 0.019777;
+    wW[1] = 0.325901;
+    wW[2] = 0.031848;
+    wW[3] = 0.147668;
+    wW[4] = 0.030609;
+    wW[5] = 0.013993;
+    wW[6] = 0.001479;
+    wW[7] = 0.048792;
+    wW[8] = 0.009477;
+    wW[9] = 0.350697;
+    wW[10] = 0.014546;
+    wW[11] = 0.005213;
+    wW[12] = 0.000000;
+    if(fByThick){// New values seeITS_MatBudget_4B.xls
+       den = 1.2464275; // g/cm^3   Cell O403
+    }else{
+       den = 1.28134409; // g/cm^3  Cell L403
+    } // end if fByThick
+    //den = 7666.3/(9753.553259); // volume does not exclude holes
+    AliMixture(87,"AIRFMDSSD$",aA,zZ,den,+12,wW); 
+    AliMedium(87,"AIRFMDSSD$",87,0,ifield,fieldm,tmaxfdAir,stemaxAir,
+             deemaxAir,epsilAir,stminAir);
+
+    //AliMaterial(88,"ITS SANDW CFMDSDD$",0.12011E+02,0.60000E+01,0.41000E+00,0.90868E+02,0.99900E+03);
+    // From Pierluigi Barberis calculations of 1SDD+Carbon fiber October 2 2002
+    wW[0] = 0.016302;
+    wW[1] = 0.461870;
+    wW[2] = 0.033662;
+    wW[3] = 0.163595;
+    wW[4] = 0.000315;
+    wW[5] = 0.001197;
+    wW[6] = 0.000127;
+    wW[7] = 0.004175;
+    wW[8] = 0.000811;
+    wW[9] = 0.311315;
+    wW[10] = 0.006631;
+    wW[11] = 0.000000;
+    wW[12] = 0.000000;
+    if(fByThick){// New values seeITS_MatBudget_4B.xls
+       den = 1.9353276; // g/cm^3  Cell N370
+    }else{
+       den = 3.2788626; // g/cm^3 Cell F370
+    } // end if fByThick
+    //den = 7667.1/(3671.58978); // Volume does not excludeholes
+    AliMixture(88,"ITS SANDW CFMDSDD$",aA,zZ,den,+11,wW); 
+    AliMedium(88,"ITS SANDW CFMDSDD$",88,0,ifield,fieldm,tmaxfd,stemax,
+             deemax,epsil,stmin);
+
+    //AliMaterial(89,"ITS SANDW CFMDSSD$",0.12011E+02,0.60000E+01,0.41000E+00,0.90868E+02,0.99900E+03);
+    // From Pierluigi Barberis calculations of SSD+Carbon fiber October 2 2002.
+    wW[0] = 0.014065;
+    wW[1] = 0.520598;
+    wW[2] = 0.022650;
+    wW[3] = 0.105018;
+    wW[4] = 0.021768;
+    wW[5] = 0.009952;
+    wW[6] = 0.001051;
+    wW[7] = 0.034700;
+    wW[8] = 0.006740;
+    wW[9] = 0.249406;
+    wW[10] = 0.010345;
+    wW[11] = 0.0003707;
+    wW[12] = 0.000000;
+    if(fByThick){// New values seeITS_MatBudget_4B.xls
+       den = 1.6564275; // g/cm^3  Cell N304
+    }else{
+       den = 1.7028296; // g/cm^3  Cell F304
+    } // end if fByThick
+    //den = 1166.5/(3671.58978); // Volume does not exclude holes
+    AliMixture(89,"ITS SANDW CFMDSSD$",aA,zZ,den,+12,wW); 
+    AliMedium(89,"ITS SANDW CFMDSSD$",89,0,ifield,fieldm,tmaxfd,stemax,
+             deemax,epsil,stmin);
+
+    //AliMaterial(97,"SPD SERVICES$",0.12011E+02,0.60000E+01,0.41000E+00,0.90868E+02,0.99900E+03);
+    // From Pierluigi Barberis calculations of 1SPD October 2 2002.
+    wW[0] = 0.005970;
+    wW[1] = 0.304704;
+    wW[2] = 0.042510;
+    wW[3] = 0.121715;
+    wW[4] = 0.001118;
+    wW[5] = 0.030948;
+    wW[6] = 0.003270;
+    wW[7] = 0.107910;
+    wW[8] = 0.020960;
+    wW[9] = 0.360895;
+    wW[10] = 0.000000;
+    wW[11] = 0.000000;
+    wW[12] = 0.000000;
+    if(fByThick){// New values seeITS_MatBudget_4B.xls
+       den = 80.31136576; // g/cm^3 Cell H329
+    }else{
+       den = 87.13062; // g/cm^3  Cell G329
+    } // end if fByThick
+    //den = 1251.3/(0.05*2.0*TMath::Pi()*(7.75*7.75 - 3.7*3.7)); // g/cm^3
+    AliMixture(97,"SPD SERVICES$",aA,zZ,den,+10,wW); 
+    AliMedium(97,"SPD SERVICES$",97,0,ifield,fieldm,tmaxfd,stemax,
+             deemax,epsil,stmin);
+
+
+    // Special media
+
+    AliMaterial(90,"SPD shield$", 12.011, 6., 1.93 , 22.36, 999);
+    AliMedium(90,"SPD shield$",90,0,ifield,fieldm,tmaxfdServ,stemaxServ,deemaxServ,epsilServ,stminServ);
+
+    // SPD End Ladder (data from Petra Riedler)
+    Float_t aSPDel[5] = {1.00794,12.0107,14.01,15.9994,63.54 };
+    Float_t zSPDel[5] = {1.,6.,7.,8.,29.};
+    Float_t wSPDel[5] = {0.004092,0.107274,0.011438,0.032476,0.844719};
+    Float_t dSPDel    = 3.903403;
+
+    //   AliMaterial(91, "SPD End ladder$", 47.0447, 21.7963, 3.6374, 4.4711, 999); 
+    AliMixture(91,"SPD End ladder$",aSPDel,zSPDel,dSPDel,5,wSPDel);
+    AliMedium(91,"SPD End ladder$",91,0,ifield,fieldm,tmaxfdServ,stemaxServ,deemaxServ,epsilServ,stminServ);
+
+    AliMaterial(92, "SPD cone$",28.0855, 14., 2.33, 9.36, 999);    
+    AliMedium(92,"SPD cone$",92,0,ifield,fieldm,tmaxfdServ,stemaxServ,deemaxServ,epsilServ,stminServ);
+    /*  Material with fractional Z not actually used
+    AliMaterial(93, "SDD End ladder$", 69.9298, 29.8246, 0.3824, 36.5103, 999);
+    AliMedium(93,"SDD End ladder$",93,0,ifield,fieldm,tmaxfdServ,stemaxServ,deemaxServ,epsilServ,stminServ);
+    */
+    AliMaterial(94, "SDD cone$",63.546, 29., 1.15, 1.265, 999);
+    AliMedium(94,"SDD cone$",94,0,ifield,fieldm,tmaxfdServ,stemaxServ,deemaxServ,epsilServ,stminServ);
+    /* Material with fractional Z not actually used
+    AliMaterial(95, "SSD End ladder$", 32.0988, 15.4021, 0.68, 35.3238, 999); 
+    AliMedium(95,"SSD End ladder$",95,0,ifield,fieldm,tmaxfdServ,stemaxServ,deemaxServ,epsilServ,stminServ);
+    */
+    AliMaterial(96, "SSD cone$",63.546, 29., 1.15, 1.265, 999);
+    AliMedium(96,"SSD cone$",96,0,ifield,fieldm,tmaxfdServ,stemaxServ,deemaxServ,epsilServ,stminServ);
+
+    AliMixture(98,"SDD OPTICFIB$",aoptfib,zoptfib,doptfib,-2,woptfib);
+    AliMedium(98,"SDD OPTICFIB$",98,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    AliMixture(95,"SSD FEP$",aFEP,zFEP,dFEP,-2,wFEP);
+    AliMedium(95,"SSD FEP$",95,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    // Mean material for low-voltage cables on SPD trays Side A
+    // (Copper + PolyEthylene (C2-H4)) (D.Elia for cable number and
+    // cross-section area, M.Sitta for elemental computation) - 26 Feb 10
+    wW[0] = 0.323024;//H
+    wW[2] = 0.515464;//Cu
+    wW[1] = 0.161512;//C
+    wW[3] = 0.000000;//O
+    wW[4] = 0.000000;//S
+    wW[5] = 0.000000;//F
+    wW[6] = 0.000000;//Sn
+    wW[7] = 0.000000;//Pb
+    wW[8] = 0.000000;//Cr
+    wW[9] = 0.000000;//Si
+    wW[10] = 0.000000;//Ni
+    wW[11] = 0.000000;//Ca
+
+    den = 5.078866;
+    AliMixture(60,"SPD_LOWCABLES$",aA,zZ,den,+3,wW);
+    AliMedium(60,"SPD_LOWCABLES$",60,0,ifield,fieldm,tmaxfd,stemax,
+             deemax,epsil,stmin);
+
+    // Mean material for high-voltage cables on SPD trays Side A & C
+    // (Copper + HD PolyEthylene (C2-H2)) (D.Elia for cable number and
+    // cross-section area, M.Sitta for elemental computation) - 10 Jun 10
+    wW[0] = 0.083766;//H
+    wW[2] = 0.417136;//Cu
+    wW[1] = 0.499098;//C
+    wW[3] = 0.000000;//O
+    wW[4] = 0.000000;//S
+    wW[5] = 0.000000;//F
+    wW[6] = 0.000000;//Sn
+    wW[7] = 0.000000;//Pb
+    wW[8] = 0.000000;//Cr
+    wW[9] = 0.000000;//Si
+    wW[10] = 0.000000;//Ni
+    wW[11] = 0.000000;//Ca
+
+    den = 1.514930;
+    AliMixture(58,"SPD_HICABLES$",aA,zZ,den,+3,wW);
+    AliMedium(58,"SPD_HICABLES$",58,0,ifield,fieldm,tmaxfd,stemax,
+             deemax,epsil,stmin);
+
+    // PolyUrethane [C25-H42-N2-O6] - 07 Mar 10
+    zZ[2] =  7.0; aA[2] =  14.0067; // Nitrogen - From Root TGeoElementTable
+
+    wW[0] = 0.090724;//H
+    wW[2] = 0.060035;//N
+    wW[1] = 0.643513;//C
+    wW[3] = 0.205728;//O
+    wW[4] = 0.000000;//S
+    wW[5] = 0.000000;//F
+    wW[6] = 0.000000;//Sn
+    wW[7] = 0.000000;//Pb
+    wW[8] = 0.000000;//Cr
+    wW[9] = 0.000000;//Si
+    wW[10] = 0.000000;//Ni
+    wW[11] = 0.000000;//Ca
+
+    den = 1.158910;
+    AliMixture(67,"POLYURETHANE$",aA,zZ,den,+4,wW);
+    AliMedium(67,"POLYURETHANE$",67,0,ifield,fieldm,tmaxfd,stemax,
+             deemax,epsil,stmin);
+
+    //  POM (Polyoxymethylene = (CH2O)n ) - 02 May 10
+    zZ[2] =  8.0; aA[2] =  15.9994; // Oxigen
+
+    wW[0] = 0.067137;//H
+    wW[1] = 0.400016;//C
+    wW[2] = 0.532847;//O
+    wW[3] = 0.000000;//O
+    wW[4] = 0.000000;//S
+    wW[5] = 0.000000;//F
+    wW[6] = 0.000000;//Sn
+    wW[7] = 0.000000;//Pb
+    wW[8] = 0.000000;//Cr
+    wW[9] = 0.000000;//Si
+    wW[10] = 0.000000;//Ni
+    wW[11] = 0.000000;//Ca
+
+    den = 1.4200;
+    AliMixture(57,"POLYOXYMETHYLENE$",aA,zZ,den,+3,wW);
+    AliMedium(57,"POLYOXYMETHYLENE$",57,0,ifield,fieldm,tmaxfd,stemax,
+             deemax,epsil,stmin);
+
+
+    // Anticorodal (Aliminum alloy) - 08 nov 10
+    // A,Z from Root TGeoElementTable, W from Web sites
+    zZ[0] = 13.0; aA[0] =  26.9815; // Aluminium
+    zZ[1] = 29.0; aA[1] =  63.546 ; // Copper
+    zZ[2] = 26.0; aA[2] =  55.845 ; // Iron
+    zZ[3] = 25.0; aA[3] =  54.938 ; // Manganese
+    zZ[4] = 12.0; aA[4] =  24.305 ; // Magnesium
+    zZ[5] = 14.0; aA[5] =  28.0855; // Silicon
+    zZ[6] = 30.0; aA[6] =  65.39  ; // Zinc
+    zZ[7] = 24.0; aA[7] =  51.9961; // Chromium
+    zZ[8] = 22.0; aA[8] =  47.867 ; // Titanium
+
+    wW[1] = 0.001000;//Cu
+    wW[2] = 0.005000;//Fe
+    wW[3] = 0.007000;//Mn - mean value
+    wW[4] = 0.009000;//Mg - mean value
+    wW[5] = 0.001000;//Si - mean value
+    wW[6] = 0.002000;//Zn
+    wW[7] = 0.002500;//Cr
+    wW[8] = 0.001000;//Ti
+
+    Double_t totFrac = 0;
+    for (Int_t j=1; j<9; j++)
+      totFrac += wW[j];
+    wW[0] = 1. - totFrac;//Al - the remainder
+
+    den = 2.69;
+    AliMixture(93,"ANTICORODAL$",aA,zZ,den,+9,wW);
+    AliMedium(93,"ANTICORODAL$",93,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+
+    // Hokotol (another Aluminium alloy) - 08 nov 10
+    // A,Z from Root TGeoElementTable, W from Web sites
+    zZ[0] = 13.0; aA[0] =  26.9815; // Aluminium
+    zZ[1] = 29.0; aA[1] =  63.546 ; // Copper
+    zZ[2] = 26.0; aA[2] =  55.845 ; // Iron
+    zZ[3] = 25.0; aA[3] =  54.938 ; // Manganese
+    zZ[4] = 12.0; aA[4] =  24.305 ; // Magnesium
+    zZ[5] = 14.0; aA[5] =  28.0855; // Silicon
+    zZ[6] = 30.0; aA[6] =  65.39  ; // Zinc
+    zZ[7] = 24.0; aA[7] =  51.9961; // Chromium
+    zZ[8] = 22.0; aA[8] =  47.867 ; // Titanium
+    zZ[9] = 40.0; aA[9] =  91.224 ; // Zirconium
+
+    wW[1] = 0.020500;//Cu - mean value
+    wW[2] = 0.000300;//Fe
+    wW[3] = 0.022000;//Mn - mean value
+    wW[4] = 0.001000;//Mg - mean value
+    wW[5] = 0.002000;//Si - mean value
+    wW[6] = 0.066500;//Zn
+    wW[7] = 0.005000;//Cr
+    wW[8] = 0.000600;//Ti
+    wW[9] = 0.001650;//Zr - mean value
+
+    totFrac = 0;
+    for (Int_t j=1; j<10; j++)
+      totFrac += wW[j];
+    wW[0] = 1. - totFrac;//Al - the remainder
+
+    den = 2.69;
+    AliMixture(34,"HOKOTOL$",aA,zZ,den,+10,wW);
+    AliMedium(34,"HOKOTOL$",34,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
+    
+    // Ergal (7075) (yet another Aluminium alloy) - 09 nov 10
+    // A,Z from Root TGeoElementTable, W from Web sites
+    zZ[0] = 13.0; aA[0] =  26.9815; // Aluminium
+    zZ[1] = 29.0; aA[1] =  63.546 ; // Copper
+    zZ[2] = 26.0; aA[2] =  55.845 ; // Iron
+    zZ[3] = 25.0; aA[3] =  54.938 ; // Manganese
+    zZ[4] = 12.0; aA[4] =  24.305 ; // Magnesium
+    zZ[5] = 14.0; aA[5] =  28.0855; // Silicon
+    zZ[6] = 30.0; aA[6] =  65.39  ; // Zinc
+    zZ[7] = 24.0; aA[7] =  51.9961; // Chromium
+    zZ[8] = 22.0; aA[8] =  47.867 ; // Titanium
+
+    wW[1] = 0.016000;//Cu - mean value
+    wW[2] = 0.005000;//Fe
+    wW[3] = 0.003000;//Mn
+    wW[4] = 0.025000;//Mg - mean value
+    wW[5] = 0.004000;//Si
+    wW[6] = 0.056000;//Zn - mean value
+    wW[7] = 0.002300;//Cr - mean value
+    wW[8] = 0.002000;//Ti
+
+    totFrac = 0;
+    for (Int_t j=1; j<9; j++)
+      totFrac += wW[j];
+    wW[0] = 1. - totFrac;//Al - the remainder
+
+    den = 2.69;
+    AliMixture(33,"ERGAL$",aA,zZ,den,+9,wW);
+    AliMedium(33,"ERGAL$",33,0,ifield,fieldm,tmaxfd,stemax,deemax,epsil,stmin);
 
-    SPDThermalSheald(Moth);
 }
+
 //______________________________________________________________________
-void AliITSv11::SPDThermalSheald(TGeoVolume *Moth){
-    // Define the detail SPD Thermal Sheld geometry.
+void AliITSv11::Init()
+{
+    //     Initialise the ITS after it has been created.
     // Inputs:
     //   none.
     // Outputs:
-    //  none.
-    // Return:
-    //  none.
-    // From ALICE-Thermal Screen (SPD) "Cylinder" file thermal-screen2_a3.ps
-    // Volumes A1,A2,A2,Ah1,Ah2,Ah3, and B1,B2,B3,Bh1,Bh2,Bh3;
-    // "CONE TRANSITION" file thermal-screen1_a3.ps Volumes C1,C2,C3,Ch1,Ch2,
-    // Ch3; "FLANGE" file thermal-screen4_a3.ps Volumes D,Ds,Dw,Dws; and 
-    // "HALF ASSEMBLY" file thermal-screen3_a3.ps. This object, both halfs,
-    // are incased inside of a single minimum sized mother volume called M,
-    // which is a union of two parts M1 and 4 copies of M2.
-    const Double_t TSCarbonFiberThA = 0.03*kmm; // 
-    //const Double_t TSCarbonFiberThB = 0.10*kmm; //
-    const Double_t TSCLengthB  = 50.0*kmm; //
-    const Double_t TSCLengthA  = 900.0*kmm-2.0*TSCLengthB; //
-    const Double_t TSCLengthC  = 290.0*kmm; //
-    const Double_t TSCLengthD  = 15.0*kmm; //
-    const Double_t TSCAngle    = 36.0*kDegree;//Rep. angle of cent. accordin
-    const Double_t TSCRoutA    = 99.255*kmm; // Outer radii
-    const Double_t TSCRinA     = 81.475*kmm; // Iner radii
-    const Double_t TSCRoutB    = 99.955*kmm; // Outer radii
-    const Double_t TSCRinB     = 80.775*kmm; // Iner radii
-    const Double_t TSCRoutCp   = 390.0*kmm;  // Outer radii
-    const Double_t TSCRinCp    = 373.0*kmm;  // Iner radii
-    Double_t TSCRoutC,TSCRinC; // values need to be calculated
-    const Double_t TSCRwingD   = 492.5*kmm;  // Outer radii
-    const Double_t TSCRoutD    = 0.5*840.*kmm;// Outer radii
-    const Double_t TSCRinD     = 373.0*kmm;  // Iner radii
-    const Double_t TSCAngleDD  = 60.*kmm/TSCRwingD/kRadian;//angular wing width
-    //angular wing width of fill material
-    const Double_t TSCAngleDDs = (60.*kmm-2.*TSCarbonFiberThA)/TSCRwingD/kRadian;
-    const Double_t TSCAngleD0  = 45.*kDegree;//Strting angle of wing
-    const Double_t TSCoutSA    = 24.372*kmm; // The other one Calculated
-    const Double_t TSCinLA     = 31.674*kmm; // The ohter one Calculated
-    const Double_t TSCoutSB    = 24.596*kmm; // The other one Calculated
-    const Double_t TSCinLB     = 31.453*kmm; // The ohter one Calculated
-    const Double_t TSCoutSC    = 148.831*kmm;// The other one Calculated
-    const Double_t TSCinLC     = 90.915*kmm; // The ohter one Calculated
-    Int_t i,k;
-    Double_t th;
-    Double_t xo[7],yo[7],xi[7],yi[7];
-    Double_t xbo[7],ybo[7],xbi[7],ybi[7];
-    Double_t xco[7],yco[7],xci[7],yci[7];
-    TGeoArb8 *A1,*A2,*A3,*Ah1,*Ah2,*Ah3,*B1,*B2,*B3,*Bh1,*Bh2,*Bh3;
-    TGeoArb8 *C1,*C2,*C3,*Ch1,*Ch2,*Ch3;
-    TGeoTube  *D,*Ds;
-    TGeoTubeSeg *Dw,*Dws,*M2;
-    TGeoPcon *M1;
-    TGeoCompositeShape *M;
-    TGeoRotation *rot;
-    TGeoTranslation *tranb,*tranbm,*tranc;
-    TGeoTranslation *tranITSspdShealdVVt0;
-    TGeoCombiTrans *rotITSspdShealdVVt1,*rotITSspdShealdVVt2;
-    TGeoCombiTrans *rotITSspdShealdVVt3;
-    TGeoMedium *SPDcf  = 0; // SPD support cone Carbon Fiber materal number.
-    TGeoMedium *SPDfs  = 0; // SPD support cone inserto stesalite 4411w.
-    TGeoMedium *SPDfo  = 0; // SPD support cone foam, Rohacell 50A.
-    TGeoMedium *SPDss  = 0; // SPD support cone screw material,Stainless steal
-    TGeoMedium *SPDair = 0; // SPD support cone Air
-    //TGeoMedium *SPDal  = 0; // SPD support cone SDD mounting bracket Al
-
-    TSCRoutC = TMath::Sqrt(TSCRoutCp*TSCRoutCp-0.25*TSCoutSC*TSCoutSC);
-    TSCRinC  = TMath::Sqrt(TSCRinCp *TSCRinCp -0.25*TSCinLC *TSCinLC );
-    A1  = new TGeoArb8("ITS SPD Therm Screen Clyinder A1",0.5*TSCLengthA);
-    A2  = new TGeoArb8("ITS SPD Therm Screen Clyinder A2",0.5*TSCLengthA);
-    A3  = new TGeoArb8("ITS SPD Therm Screen Clyinder A3",0.5*TSCLengthA);
-    Ah1 = new TGeoArb8("ITS SPD Therm Screen Cylinder Ah1",0.5*TSCLengthA);
-    Ah2 = new TGeoArb8("ITS SPD Therm Screen Cylinder Ah2",0.5*TSCLengthA);
-    Ah3 = new TGeoArb8("ITS SPD Therm Screen Cylinder Ah3",0.5*TSCLengthA);
-    B1  = new TGeoArb8("ITS SPD Therm Screen Clyinder B1",0.5*TSCLengthB);
-    B2  = new TGeoArb8("ITS SPD Therm Screen Clyinder B2",0.5*TSCLengthB);
-    B3  = new TGeoArb8("ITS SPD Therm Screen Clyinder B3",0.5*TSCLengthB);
-    Bh1 = new TGeoArb8("ITS SPD Therm Screen Cylinder Bh1",0.5*TSCLengthB);
-    Bh2 = new TGeoArb8("ITS SPD Therm Screen Cylinder Bh2",0.5*TSCLengthB);
-    Bh3 = new TGeoArb8("ITS SPD Therm Screen Cylinder Bh3",0.5*TSCLengthB);
-    C1  = new TGeoArb8("ITS SPD Therm Screen Clyinder C1",0.5*TSCLengthC);
-    C2  = new TGeoArb8("ITS SPD Therm Screen Clyinder C2",0.5*TSCLengthC);
-    C3  = new TGeoArb8("ITS SPD Therm Screen Clyinder C3",0.5*TSCLengthC);
-    Ch1 = new TGeoArb8("ITS SPD Therm Screen Cylinder Ch1",0.5*TSCLengthC);
-    Ch2 = new TGeoArb8("ITS SPD Therm Screen Cylinder Ch2",0.5*TSCLengthC);
-    Ch3 = new TGeoArb8("ITS SPD Therm Screen Cylinder Ch3",0.5*TSCLengthC);
-    D = new TGeoTube("ITS SPD Therm Screen Flange D",TSCRinD,TSCRoutD,
-                    0.5*TSCLengthD);
-    Ds = new TGeoTube("ITS SPD Therm Screen Flange fill Ds",
-                      TSCRinD+TSCarbonFiberThA,TSCRoutD-TSCarbonFiberThA,
-                      0.5*TSCLengthD);
-    printTube(D);
-    printTube(Ds);
-    Dw = new TGeoTubeSeg("ITS SPD Therm Screen Flange Wing Dw",
-                         TSCRoutD,TSCRwingD ,0.5*TSCLengthD,
-                         TSCAngleD0-0.5*TSCAngleDD,TSCAngleD0+0.5*TSCAngleDD);
-    Dws = new TGeoTubeSeg("ITS SPD Therm Screen Flange Wing Fill Ds",
-                          TSCRoutD,TSCRwingD-TSCarbonFiberThA,
-                          0.5*TSCLengthD,TSCAngleD0-0.5*TSCAngleDDs,
-                          TSCAngleD0+0.5*TSCAngleDDs);
-    printTubeSeg(Dw);
-    printTubeSeg(Dws);
-    k = 0;
-    for(i=-1;i<2;i++){
-      th = ((Double_t)(i+1))*TSCAngle*kRadian;
-      xo[k] = TSCRoutA*TMath::Sin(th) - 0.5*TSCoutSA*TMath::Cos(th);
-      yo[k] = TSCRoutA*TMath::Cos(th) + 0.5*TSCoutSA*TMath::Sin(th);
-      xi[k] = TSCRinA *TMath::Sin(th) - 0.5*TSCinLA *TMath::Cos(th);
-      yi[k] = TSCRinA *TMath::Cos(th) + 0.5*TSCinLA *TMath::Sin(th);
-      xbo[k] = TSCRoutB*TMath::Sin(th) - 0.5*TSCoutSB*TMath::Cos(th);
-      ybo[k] = TSCRoutB*TMath::Cos(th) + 0.5*TSCoutSB*TMath::Sin(th);
-      xbi[k] = TSCRinB *TMath::Sin(th) - 0.5*TSCinLB *TMath::Cos(th);
-      ybi[k] = TSCRinB *TMath::Cos(th) + 0.5*TSCinLB *TMath::Sin(th);
-      xco[k] = TSCRoutC*TMath::Sin(th) - 0.5*TSCoutSC*TMath::Cos(th);
-      yco[k] = TSCRoutC*TMath::Cos(th) + 0.5*TSCoutSC*TMath::Sin(th);
-      xci[k] = TSCRinC *TMath::Sin(th) - 0.5*TSCinLC *TMath::Cos(th);
-      yci[k] = TSCRinC *TMath::Cos(th) + 0.5*TSCinLC *TMath::Sin(th);
-      k++;
-      xo[k] = TSCRoutA*TMath::Sin(th) + 0.5*TSCoutSA*TMath::Cos(th);
-      yo[k] = TSCRoutA*TMath::Cos(th) - 0.5*TSCoutSA*TMath::Sin(th);
-      xi[k] = TSCRinA *TMath::Sin(th) + 0.5*TSCinLA *TMath::Cos(th);
-      yi[k] = TSCRinA *TMath::Cos(th) - 0.5*TSCinLA *TMath::Sin(th);
-      xbo[k] = TSCRoutB*TMath::Sin(th) + 0.5*TSCoutSB*TMath::Cos(th);
-      ybo[k] = TSCRoutB*TMath::Cos(th) - 0.5*TSCoutSB*TMath::Sin(th);
-      xbi[k] = TSCRinB *TMath::Sin(th) + 0.5*TSCinLB *TMath::Cos(th);
-      ybi[k] = TSCRinB *TMath::Cos(th) - 0.5*TSCinLB *TMath::Sin(th);
-      xco[k] = TSCRoutC*TMath::Sin(th) + 0.5*TSCoutSC*TMath::Cos(th);
-      yco[k] = TSCRoutC*TMath::Cos(th) - 0.5*TSCoutSC*TMath::Sin(th);
-      xci[k] = TSCRinC *TMath::Sin(th) + 0.5*TSCinLC *TMath::Cos(th);
-      yci[k] = TSCRinC *TMath::Cos(th) - 0.5*TSCinLC *TMath::Sin(th);
-      k++;
-    } // end for i
-    xo[6] = xo[5];
-    yo[6] = 0.0;
-    xi[6] = xi[5];
-    yi[6] = 0.0;
-    xbo[6] = xbo[5];
-    ybo[6] = 0.0;
-    xbi[6] = xbi[5];
-    ybi[6] = 0.0;
-    xco[6] = xco[5];
-    yco[6] = 0.0;
-    xci[6] = xci[5];
-    yci[6] = 0.0;
-    if(GetDebug()){
-    cout.precision(4);
-    cout.width(7);
-    cout <<"i     \t  xo  yo    \t  xi yi     \t  xbo ybo   \t   xbi ybi  "
-        "\t   xco yco   \t   xci yxi"<<endl;
-    for(i=0;i<7;i++){
-        cout << i <<"\t"<<xo[i]<<","<<yo[i];
-        cout      <<"\t"<<xi[i]<<","<<yi[i];
-        cout      <<"\t"<<xbo[i]<<","<<ybo[i];
-        cout      <<"\t"<<xbi[i]<<","<<ybi[i];
-        cout      <<"\t"<<xco[i]<<","<<yco[i];
-        cout      <<"\t"<<xci[i]<<","<<yci[i];
-        cout<<endl;}
-    } // end if GetDebug()
-    //+++++++++++++++++++++++++
-    A1->SetVertex(0,xo[0],yo[0]);
-    A1->SetVertex(1,xo[1],yo[1]);
-    A1->SetVertex(2,xi[1],yi[1]);
-    A1->SetVertex(3,xi[0],yi[0]);
-    //
-    A2->SetVertex(0,xo[1],yo[1]);
-    A2->SetVertex(1,xo[2],yo[2]);
-    A2->SetVertex(2,xi[2],yi[2]);
-    A2->SetVertex(3,xi[1],yi[1]);
-    //
-    A3->SetVertex(0,xo[5],yo[5]);
-    A3->SetVertex(1,xo[6],yo[6]);
-    A3->SetVertex(2,xi[6],yi[6]);
-    A3->SetVertex(3,xi[5],yi[5]);
-    //--------------------------
-    B1->SetVertex(0,xbo[0],ybo[0]);
-    B1->SetVertex(1,xbo[1],ybo[1]);
-    B1->SetVertex(2,xbi[1],ybi[1]);
-    B1->SetVertex(3,xbi[0],ybi[0]);
-    //
-    B2->SetVertex(0,xbo[1],ybo[1]);
-    B2->SetVertex(1,xbo[2],ybo[2]);
-    B2->SetVertex(2,xbi[2],ybi[2]);
-    B2->SetVertex(3,xbi[1],ybi[1]);
-    //
-    B3->SetVertex(0,xbo[5],ybo[5]);
-    B3->SetVertex(1,xbo[6],ybo[6]);
-    B3->SetVertex(2,xbi[6],ybi[6]);
-    B3->SetVertex(3,xbi[5],ybi[5]);
-    //--------------------------
-    C1->SetVertex(0,xco[0],yco[0]);
-    C1->SetVertex(1,xco[1],yco[1]);
-    C1->SetVertex(2,xci[1],yci[1]);
-    C1->SetVertex(3,xci[0],yci[0]);
-    //
-    C2->SetVertex(0,xco[1],yco[1]);
-    C2->SetVertex(1,xco[2],yco[2]);
-    C2->SetVertex(2,xci[2],yci[2]);
-    C2->SetVertex(3,xci[1],yci[1]);
-    //
-    C3->SetVertex(0,xco[5],yco[5]);
-    C3->SetVertex(1,xco[6],yco[6]);
-    C3->SetVertex(2,xci[6],yci[6]);
-    C3->SetVertex(3,xci[5],yci[5]);
-    // Defining the hole, filled with air
-    Double_t p1,c1,x,y,x7[3],y7[3];
-    p1 = (xo[0]-xi[0])/(yo[0]-yi[0]);
-    c1 = xo[0]+0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(xo[0]-xi[0])+
-                                                SQ(yo[0]-yi[0]))/(xo[0]-xi[0]);
-    y = TSCRoutA-2.*TSCarbonFiberThA;
-    x = p1*(y-yo[0])+c1;
-    Ah1->SetVertex(0,x,y);
-    Bh1->SetVertex(0,x,y);
-    Ch1->SetVertex(4,x,y);
-    y = TSCRinA+TSCarbonFiberThA;
-    x = p1*(y-yo[0])+c1;
-    Ah1->SetVertex(3,x,y);
-    Bh1->SetVertex(3,x,y);
-    x7[0] = x; y7[0] = y; // vortexing done after last point
-    //Ch1->SetVertex(7,x,y);
-    p1 = (xo[1]-xi[1])/(yo[1]-yi[1]);
-    c1 = xo[1]-0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(xo[1]-xi[1])+
-                                                SQ(yo[1]-yi[1]))/(xo[1]-xi[1]);
-    y = TSCRoutA-2.*TSCarbonFiberThA;
-    x = p1*(y-yo[1])+c1;
-    Ah1->SetVertex(1,x,y);
-    Bh1->SetVertex(1,x,y);
-    Ch1->SetVertex(5,x,y);
-    y = TSCRinA+TSCarbonFiberThA;
-    x = p1*(y-yo[1])+c1;
-    Ah1->SetVertex(2,x,y);
-    Bh1->SetVertex(2,x,y);
-    Ch1->SetVertex(6,x,y);
-    //
-    // The easist way to get the points for the hole in volume A2 is to
-    // rotate it to the Y axis where the y coordinates are easier to know
-    // and then rotate it back.
-    Double_t xp,yp,xa,ya,xb,yb;
-    th = 0.5*TSCAngle*kRadian;
-    xa = TMath::Cos(th)*xo[1]-TMath::Sin(th)*yo[1];
-    ya = TMath::Sin(th)*xo[1]+TMath::Cos(th)*yo[1];
-    xb = TMath::Cos(th)*xi[1]-TMath::Sin(th)*yi[1];
-    yb = TMath::Sin(th)*xi[1]+TMath::Cos(th)*yi[1];
-    p1 = (xa-xb)/(ya-yb);
-    c1 = xa+0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(xa-xb)+SQ(ya-yb))/(xa-xb);
-    y = ya-TSCarbonFiberThA;
-    x = p1*(y-ya)+c1;
-    xp = TMath::Cos(-th)*x-TMath::Sin(-th)*y;
-    yp = TMath::Sin(-th)*x+TMath::Cos(-th)*y;
-    Ah2->SetVertex(0,xp,yp);
-    Bh2->SetVertex(0,xp,yp);
-    Ch2->SetVertex(4,xp,yp);
-    y = yb+2.0*TSCarbonFiberThA;
-    x = p1*(y-ya)+c1;
-    xp = TMath::Cos(-th)*x-TMath::Sin(-th)*y;
-    yp = TMath::Sin(-th)*x+TMath::Cos(-th)*y;
-    Ah2->SetVertex(3,xp,yp);
-    Bh2->SetVertex(3,xp,yp);
-    x7[1] = x; y7[1] = y; // vortexing done after last point
-    //Ch2->SetVertex(7,xp,yp);
-    xa = TMath::Cos(th)*xo[2]-TMath::Sin(th)*yo[2];
-    ya = TMath::Sin(th)*xo[2]+TMath::Cos(th)*yo[2];
-    xb = TMath::Cos(th)*xi[2]-TMath::Sin(th)*yi[2];
-    yb = TMath::Sin(th)*xi[2]+TMath::Cos(th)*yi[2];
-    p1 = (xa-xb)/(ya-yb);
-    c1 = xa-0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(xa-xb)+SQ(ya-yb))/(xa-xb);
-    y = ya-TSCarbonFiberThA;
-    x = p1*(y-ya)+c1;
-    xp = TMath::Cos(-th)*x-TMath::Sin(-th)*y;
-    yp = TMath::Sin(-th)*x+TMath::Cos(-th)*y;
-    Ah2->SetVertex(1,xp,yp);
-    Bh2->SetVertex(1,xp,yp);
-    Ch2->SetVertex(5,xp,yp);
-    y = yb+2.0*TSCarbonFiberThA;
-    x = p1*(y-ya)+c1;
-    xp = TMath::Cos(-th)*x-TMath::Sin(-th)*y;
-    yp = TMath::Sin(-th)*x+TMath::Cos(-th)*y;
-    Ah2->SetVertex(2,xp,yp);
-    Bh2->SetVertex(2,xp,yp);
-    Ch2->SetVertex(6,xp,yp);
-    //
-    p1 = (yo[5]-yi[5])/(xo[5]-xi[5]);
-    c1 = yo[5]+0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(yo[5]-yi[5])+
-                                                SQ(xo[5]-xi[5]))/(yo[5]-yi[5]);
-    x = xo[5]-TSCarbonFiberThA;
-    y = p1*(x-xo[5])+c1;
-    Ah3->SetVertex(0,x,y);
-    Bh3->SetVertex(0,x,y);
-    Ch3->SetVertex(4,x,y);
-    x = xi[5]+2.0*TSCarbonFiberThA;
-    y = p1*(x-xo[5])+c1;
-    Ah3->SetVertex(3,x,y);
-    Bh3->SetVertex(3,x,y);
-    x7[2] = x; y7[2] = y; // vortexing done after last point
-    //Ch3->SetVertex(7,x,y);
-    y = 2.0*TSCarbonFiberThA;
-    x = xo[5]-TSCarbonFiberThA;
-    Ah3->SetVertex(1,x,y);
-    Bh3->SetVertex(1,x,y);
-    Ch3->SetVertex(5,x,y);
-    y = 2.0*TSCarbonFiberThA;
-    x = xi[5]+2.0*TSCarbonFiberThA;
-    Ah3->SetVertex(2,x,y);
-    Bh3->SetVertex(2,x,y);
-    Ch3->SetVertex(6,x,y);
-    //
-    for(i=0;i<4;i++){ // define points at +dz
-      A1->SetVertex(i+4,(A1->GetVertices())[2*i],(A1->GetVertices())[1+2*i]);
-      A2->SetVertex(i+4,(A2->GetVertices())[2*i],(A2->GetVertices())[1+2*i]);
-      A3->SetVertex(i+4,(A3->GetVertices())[2*i],(A3->GetVertices())[1+2*i]);
-      //
-      B1->SetVertex(i+4,(B1->GetVertices())[2*i],(B1->GetVertices())[1+2*i]);
-      B2->SetVertex(i+4,(B2->GetVertices())[2*i],(B2->GetVertices())[1+2*i]);
-      B3->SetVertex(i+4,(B3->GetVertices())[2*i],(B3->GetVertices())[1+2*i]);
-      // C's are a cone which must match up with B's.
-      C1->SetVertex(i+4,(B1->GetVertices())[2*i],(B1->GetVertices())[1+2*i]);
-      C2->SetVertex(i+4,(B2->GetVertices())[2*i],(B2->GetVertices())[1+2*i]);
-      C3->SetVertex(i+4,(B3->GetVertices())[2*i],(B3->GetVertices())[1+2*i]);
-      //
-      Ah1->SetVertex(i+4,(Ah1->GetVertices())[2*i],
-                         (Ah1->GetVertices())[1+2*i]);
-      Ah2->SetVertex(i+4,(Ah2->GetVertices())[2*i],
-                         (Ah2->GetVertices())[1+2*i]);
-      Ah3->SetVertex(i+4,(Ah3->GetVertices())[2*i],
-                         (Ah3->GetVertices())[1+2*i]);
-      //
-      Bh1->SetVertex(i+4,(Bh1->GetVertices())[2*i],
-                         (Bh1->GetVertices())[1+2*i]);
-      Bh2->SetVertex(i+4,(Bh2->GetVertices())[2*i],
-                         (Bh2->GetVertices())[1+2*i]);
-      Bh3->SetVertex(i+4,(Bh3->GetVertices())[2*i],
-                         (Bh3->GetVertices())[1+2*i]);
-    } // end for
-    //
-    p1 = (xco[0]-xci[0])/(yco[0]-yci[0]);
-    c1 = xco[0]+0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(xco[0]-xci[0])+
-                                           SQ(yco[0]-yci[0]))/(xco[0]-xci[0]);
-    y = TSCRoutC-2.*TSCarbonFiberThA;
-    x = p1*(y-yco[0])+c1;
-    Ch1->SetVertex(0,x,y);
-    y = TSCRinC+TSCarbonFiberThA;
-    x = p1*(y-yci[0])+c1;
-    Ch1->SetVertex(2,x,y);
-    p1 = (xco[1]-xci[1])/(yco[1]-yci[1]);
-    c1 = xco[1]-0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(xco[1]-xci[1])+
-                                           SQ(yco[1]-yci[1]))/(xco[1]-xci[1]);
-    y = TSCRoutC-2.*TSCarbonFiberThA;
-    x = p1*(y-yco[1])+c1;
-    Ch1->SetVertex(1,x,y);
-    y = TSCRinC+TSCarbonFiberThA;
-    x = p1*(y-yci[1])+c1;
-    Ch1->SetVertex(3,x,y);
-    //
-    th = 0.5*TSCAngle*kRadian;
-    xa = TMath::Cos(th)*xco[1]-TMath::Sin(th)*yco[1];
-    ya = TMath::Sin(th)*xco[1]+TMath::Cos(th)*yco[1];
-    xb = TMath::Cos(th)*xci[1]-TMath::Sin(th)*yci[1];
-    yb = TMath::Sin(th)*xci[1]+TMath::Cos(th)*yci[1];
-    p1 = (xa-xb)/(ya-yb);
-    c1 = xa+0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(xa-xb)+SQ(ya-yb))/(xa-xb);
-    y = ya-TSCarbonFiberThA;
-    x = p1*(y-ya)+c1;
-    xp = TMath::Cos(-th)*x-TMath::Sin(-th)*y;
-    yp = TMath::Sin(-th)*x+TMath::Cos(-th)*y;
-    yp = ya-TSCarbonFiberThA;
-    xp = p1*(y-ya)+c1;
-    Ch2->SetVertex(0,xp,yp);
-    y = yb+2.0*TSCarbonFiberThA;
-    x = p1*(y-ya)+c1;
-    xp = TMath::Cos(-th)*x-TMath::Sin(-th)*y;
-    yp = TMath::Sin(-th)*x+TMath::Cos(-th)*y;
-    Ch2->SetVertex(2,xp,yp);
-    xa = TMath::Cos(th)*xco[2]-TMath::Sin(th)*yco[2];
-    ya = TMath::Sin(th)*xco[2]+TMath::Cos(th)*yco[2];
-    xb = TMath::Cos(th)*xci[2]-TMath::Sin(th)*yci[2];
-    yb = TMath::Sin(th)*xci[2]+TMath::Cos(th)*yci[2];
-    p1 = (xa-xb)/(ya-yb);
-    c1 = xa-0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(xa-xb)+SQ(ya-yb))/(xa-xb);
-    y = ya-TSCarbonFiberThA;
-    x = p1*(y-ya)+c1;
-    xp = TMath::Cos(-th)*x-TMath::Sin(-th)*y;
-    yp = TMath::Sin(-th)*x+TMath::Cos(-th)*y;
-    Ch2->SetVertex(1,xp,yp);
-    y = yb+2.0*TSCarbonFiberThA;
-    x = p1*(y-ya)+c1;
-    xp = TMath::Cos(-th)*x-TMath::Sin(-th)*y;
-    yp = TMath::Sin(-th)*x+TMath::Cos(-th)*y;
-    Ch2->SetVertex(3,xp,yp);
-    //
-    p1 = (yco[5]-yci[5])/(xco[5]-xci[5]);
-    c1 = yco[5]+0.5*TSCarbonFiberThA*TMath::Sqrt(SQ(yco[5]-yci[5])+
-                                          SQ(xco[5]-xci[5]))/(yco[5]-yci[5]);
-    x = xco[5]-TSCarbonFiberThA;
-    y = p1*(x-xco[5])+c1;
-    Ch3->SetVertex(0,x,y);
-    x = xci[5]+2.0*TSCarbonFiberThA;
-    y = p1*(x-xci[5])+c1;
-    Ch3->SetVertex(2,x,y);
-    y = 2.0*TSCarbonFiberThA;
-    x = xco[5]-TSCarbonFiberThA;
-    Ch3->SetVertex(1,x,y);
-    y = 2.0*TSCarbonFiberThA;
-    x = xci[5]+2.0*TSCarbonFiberThA;
-    Ch3->SetVertex(3,x,y);
-    Ch1->SetVertex(7,x7[0],y7[0]); // 7th point most be done last ???
-    Ch2->SetVertex(7,x7[1],y7[1]); // 7th point most be done last ???
-    Ch3->SetVertex(7,x7[2],y7[2]); // 7th point most be done last ???
-    printArb8(A1);
-    printArb8(Ah1);
-    printArb8(A2);
-    printArb8(Ah2);
-    printArb8(A3);
-    printArb8(Ah3);
-    printArb8(B1);
-    printArb8(Bh1);
-    printArb8(B2);
-    printArb8(Bh2);
-    printArb8(B3);
-    printArb8(Bh3);
-    printArb8(C1);
-    printArb8(Ch1);
-    printArb8(C2);
-    printArb8(Ch2);
-    printArb8(C3);
-    printArb8(Ch3);
-    //
-    // Define Minimal volume to inclose this SPD Thermal Sheald.
-    M1 = new TGeoPcon("ITSspdShealdVV",0.0,360.0,9);
-    M1->Z(0)    = 0.5*TSCLengthA+TSCLengthB;
-    M1->Rmin(0) = TSCRinB;
-    x = B1->GetVertices()[0]; // [0][0]
-    y = B1->GetVertices()[1]; // [0][1]
-    M1->Rmax(0) = TMath::Sqrt(x*x+y*y);
-    M1->Z(1)    = M1->GetZ(0)-TSCLengthB;
-    M1->Rmin(1) = M1->GetRmin(0);
-    M1->Rmax(1) = M1->GetRmax(0);
-    M1->Z(2)    = M1->GetZ(1);
-    M1->Rmin(2) = TSCRinA;
-    x = A1->GetVertices()[0]; // [0]0]
-    y = A1->GetVertices()[1]; // [0][1]
-    M1->Rmax(2) = TMath::Sqrt(x*x+y*y);
-    M1->Z(3)    = -(M1->GetZ(0)-TSCLengthB);
-    M1->Rmin(3) = M1->GetRmin(2);
-    M1->Rmax(3) = M1->GetRmax(2);
-    M1->Z(4)    = M1->GetZ(3);
-    M1->Rmin(4) = M1->GetRmin(1);
-    M1->Rmax(4) = M1->GetRmax(1);
-    M1->Z(5)    = -(M1->GetZ(0));
-    M1->Rmin(5) = M1->GetRmin(0);
-    M1->Rmax(5) = M1->GetRmax(0);
-    M1->Z(6)    = M1->GetZ(5) - TSCLengthC;
-    M1->Rmin(6) = TSCRinC;
-    x = C1->GetVertices()[0]; // [0][0]
-    y = C1->GetVertices()[1]; // [0][1]
-    M1->Rmax(6) = TMath::Sqrt(x*x+y*y);
-    M1->Z(7)    = M1->GetZ(6);
-    M1->Rmin(7) = D->GetRmin();
-    M1->Rmax(7) = D->GetRmax();
-    M1->Z(8)    = M1->Z(7) - TSCLengthD;
-    M1->Rmin(8) = M1->GetRmin(7);
-    M1->Rmax(8) = M1->GetRmax(7);
-    M2 = new TGeoTubeSeg("ITSspdShealdWingVV",
-         M1->GetRmax(8),Dw->GetRmax(),Dw->GetDz(),Dw->GetPhi1(),Dw->GetPhi2());
-    printTubeSeg(M2);
-    //
-    x = 0.5*(M1->GetZ(8) + M1->GetZ(7));
-    tranITSspdShealdVVt0 = new TGeoTranslation("ITSspdShealdVVt0",0.0,0.0,x);
-    tranITSspdShealdVVt0->RegisterYourself();
-    TGeoRotation rotz90("",0.0,0.0,90.0); // never registered.
-    rotITSspdShealdVVt1 = new TGeoCombiTrans(*tranITSspdShealdVVt0,rotz90);
-    rotITSspdShealdVVt1->SetName("ITSspdShealdVVt1");
-    rotITSspdShealdVVt1->RegisterYourself();
-    TGeoRotation rotz180("",0.0,0.0,180.0); // never registered
-    rotITSspdShealdVVt2 = new TGeoCombiTrans(*tranITSspdShealdVVt0,rotz180);
-    rotITSspdShealdVVt2->SetName("ITSspdShealdVVt2");
-    rotITSspdShealdVVt2->RegisterYourself();
-    TGeoRotation rotz270("",0.0,0.0,270.0); // never registered
-    rotITSspdShealdVVt3 = new TGeoCombiTrans(*tranITSspdShealdVVt0,rotz270);
-    rotITSspdShealdVVt3->SetName("ITSspdShealdVVt3");
-    rotITSspdShealdVVt3->RegisterYourself();
-    M = new TGeoCompositeShape("ITS SPD Thermal sheald volume",
-                              "(((ITSspdShealdVV+"
-                              "ITSspdShealdWingVV:ITSspdShealdVVt0)+"
-                              "ITSspdShealdWingVV:ITSspdShealdVVt1)+"
-                              "ITSspdShealdWingVV:ITSspdShealdVVt2)+"
-                              "ITSspdShealdWingVV:ITSspdShealdVVt3");
-    //
-    TGeoManager *mgr = gGeoManager;
-    SPDcf = mgr->GetMedium("ITSspdCarbonFiber");
-    SPDfs = mgr->GetMedium("ITSspdStaselite4411w");
-    SPDfo = mgr->GetMedium("ITSspdRohacell50A");
-    SPDss = mgr->GetMedium("ITSspdStainlessSteal");
-    SPDair= mgr->GetMedium("ITSspdAir");
-    TGeoVolume *A1v,*A2v,*A3v,*Ah1v,*Ah2v,*Ah3v;
-    TGeoVolume *B1v,*B2v,*B3v,*Bh1v,*Bh2v,*Bh3v;
-    TGeoVolume *C1v,*C2v,*C3v,*Ch1v,*Ch2v,*Ch3v;
-    TGeoVolume *Dv,*Dsv,*Dwv,*Dwsv,*Mv;
-    Mv = new TGeoVolume("ITSspdThermalSheald",M,SPDair);
-    Mv->SetVisibility(kTRUE);
-    Mv->SetLineColor(7); // light Blue
-    Mv->SetLineWidth(1);
-    Mv->SetFillColor(Mv->GetLineColor());
-    Mv->SetFillStyle(4090); // 90% transparent
-    Moth->AddNode(Mv,1,0); ///////////////////// Virtual Volume ////////
-    A1v = new TGeoVolume("ITSspdCentCylA1CF",A1,SPDcf);
-    A1v->SetVisibility(kTRUE);
-    A1v->SetLineColor(4);
-    A1v->SetLineWidth(1);
-    A2v = new TGeoVolume("ITSspdCentCylA2CF",A2,SPDcf);
-    A2v->SetVisibility(kTRUE);
-    A2v->SetLineColor(4);
-    A2v->SetLineWidth(1);
-    A3v = new TGeoVolume("ITSspdCentCylA3CF",A3,SPDcf);
-    A3v->SetVisibility(kTRUE);
-    A3v->SetLineColor(4);
-    A3v->SetLineWidth(1);
-    B1v = new TGeoVolume("ITSspdCentCylB1CF",B1,SPDcf);
-    B1v->SetVisibility(kTRUE);
-    B1v->SetLineColor(4);
-    B1v->SetLineWidth(1);
-    B2v = new TGeoVolume("ITSspdCentCylB2CF",B2,SPDcf);
-    B2v->SetVisibility(kTRUE);
-    B2v->SetLineColor(4);
-    B2v->SetLineWidth(1);
-    B3v = new TGeoVolume("ITSspdCentCylB3CF",B3,SPDcf);
-    B3v->SetVisibility(kTRUE);
-    B3v->SetLineColor(4);
-    B3v->SetLineWidth(1);
-    C1v = new TGeoVolume("ITSspdCentCylC1CF",C1,SPDcf);
-    C1v->SetVisibility(kTRUE);
-    C1v->SetLineColor(4);
-    C1v->SetLineWidth(1);
-    C2v = new TGeoVolume("ITSspdCentCylC2CF",C2,SPDcf);
-    C2v->SetVisibility(kTRUE);
-    C2v->SetLineColor(4);
-    C2v->SetLineWidth(1);
-    C3v = new TGeoVolume("ITSspdCentCylC3CF",C3,SPDcf);
-    C3v->SetVisibility(kTRUE);
-    C3v->SetLineColor(4);
-    C3v->SetLineWidth(1);
-    Ah1v = new TGeoVolume("ITSspdCentCylA1AirA",Ah1,SPDair);
-    Ah1v->SetVisibility(kTRUE);
-    Ah1v->SetLineColor(5); // Yellow
-    Ah1v->SetFillColor(Ah1v->GetLineColor());
-    Ah1v->SetFillStyle(4090); // 90% transparent
-    Ah2v = new TGeoVolume("ITSspdCentCylA2AirA",Ah2,SPDair);
-    Ah2v->SetVisibility(kTRUE);
-    Ah2v->SetLineColor(5); // Yellow
-    Ah2v->SetFillColor(Ah2v->GetLineColor());
-    Ah2v->SetFillStyle(4090); // 90% transparent
-    Ah3v = new TGeoVolume("ITSspdCentCylA3AirA",Ah3,SPDair);
-    Ah3v->SetVisibility(kTRUE);
-    Ah3v->SetLineColor(5); // Yellow
-    Ah3v->SetFillColor(Ah3v->GetLineColor());
-    Ah3v->SetFillStyle(4090); // 90% transparent
-    Bh1v = new TGeoVolume("ITSspdCentCylA1AirB",Bh1,SPDair);
-    Bh1v->SetVisibility(kTRUE);
-    Bh1v->SetLineColor(5); // Yellow
-    Bh1v->SetFillColor(Bh1v->GetLineColor());
-    Bh1v->SetFillStyle(4090); // 90% transparent
-    Bh2v = new TGeoVolume("ITSspdCentCylA2AirB",Bh2,SPDair);
-    Bh2v->SetVisibility(kTRUE);
-    Bh2v->SetLineColor(5); // Yellow
-    Bh2v->SetFillColor(Bh2v->GetLineColor());
-    Bh2v->SetFillStyle(4090); // 90% transparent
-    Bh3v = new TGeoVolume("ITSspdCentCylA3AirB",Bh3,SPDair);
-    Bh3v->SetVisibility(kTRUE);
-    Bh3v->SetLineColor(5); // Yellow
-    Bh3v->SetFillColor(Bh3v->GetLineColor());
-    Bh3v->SetFillStyle(4090); // 90% transparent
-    Ch1v = new TGeoVolume("ITSspdCentCylA1AirC",Ch1,SPDair);
-    Ch1v->SetVisibility(kTRUE);
-    Ch1v->SetLineColor(5); // Yellow
-    Ch1v->SetFillColor(Ch1v->GetLineColor());
-    Ch1v->SetFillStyle(4090); // 90% transparent
-    Ch2v = new TGeoVolume("ITSspdCentCylA2AirC",Ch2,SPDair);
-    Ch2v->SetVisibility(kTRUE);
-    Ch2v->SetLineColor(5); // Yellow
-    Ch2v->SetFillColor(Ch2v->GetLineColor());
-    Ch2v->SetFillStyle(4090); // 90% transparent
-    Ch3v = new TGeoVolume("ITSspdCentCylA3AirC",Ch3,SPDair);
-    Ch3v->SetVisibility(kTRUE);
-    Ch3v->SetLineColor(5); // Yellow
-    Ch3v->SetFillColor(Ch3v->GetLineColor());
-    Ch3v->SetFillStyle(4090); // 90% transparent
-    Dv = new TGeoVolume("ITSspdCentCylA1CD",D,SPDcf);
-    Dv->SetVisibility(kTRUE);
-    Dv->SetLineColor(4);
-    Dv->SetLineWidth(1);
-    Dwv = new TGeoVolume("ITSspdCentCylA1CDw",Dw,SPDcf);
-    Dwv->SetVisibility(kTRUE);
-    Dwv->SetLineColor(4);
-    Dwv->SetLineWidth(1);
-    Dsv = new TGeoVolume("ITSspdCentCylA1Dfill",Ds,SPDfs);
-    Dsv->SetVisibility(kTRUE);
-    Dsv->SetLineColor(3); // Green
-    Dsv->SetFillColor(Dsv->GetLineColor());
-    Dsv->SetFillStyle(4010); // 10% transparent
-    Dwsv = new TGeoVolume("ITSspdCentCylA1DwingFill",Dws,SPDfs);
-    Dwsv->SetVisibility(kTRUE);
-    Dwsv->SetLineColor(3); // Green
-    Dwsv->SetFillColor(Dwsv->GetLineColor());
-    Dwsv->SetFillStyle(4010); // 10% transparent
-    //
-    A1v->AddNode(Ah1v,1,0);
-    A2v->AddNode(Ah2v,1,0);
-    A3v->AddNode(Ah3v,1,0);
-    B1v->AddNode(Bh1v,1,0);
-    B2v->AddNode(Bh2v,1,0);
-    B3v->AddNode(Bh3v,1,0);
-    C1v->AddNode(Ch1v,1,0);
-    C2v->AddNode(Ch2v,1,0);
-    C3v->AddNode(Ch3v,1,0);
-    Dv ->AddNode(Dsv ,1,0);
-    Dwv->AddNode(Dwsv,1,0);
-    //
-    Mv->AddNode(A1v,1,0);
-    Mv->AddNode(A2v,1,0);
-    Mv->AddNode(A3v,1,0);
-    tranb  = new TGeoTranslation("",0.0,0.0,0.5*(TSCLengthA+TSCLengthB));
-    tranbm = new TGeoTranslation("",0.0,0.0,0.5*(-TSCLengthA-TSCLengthB));
-    Mv->AddNode(B1v,1,tranb);
-    Mv->AddNode(B2v,1,tranb);
-    Mv->AddNode(B3v,1,tranb);
-    Mv->AddNode(B1v,2,tranbm);
-    Mv->AddNode(B2v,2,tranbm);
-    Mv->AddNode(B3v,2,tranbm);
-    // Muon side (rb26) is at -Z.
-    tranc = new TGeoTranslation("",0.0,0.0,
-                                0.5*(-TSCLengthA-TSCLengthB-TSCLengthC));
-    Mv->AddNode(C1v,1,tranc);
-    Mv->AddNode(C2v,1,tranc);
-    Mv->AddNode(C3v,1,tranc);
-    Mv->AddNode(Dv,1,tranITSspdShealdVVt0);
-    Mv->AddNode(Dwv,1,tranITSspdShealdVVt0);
-    Mv->AddNode(Dwv,2,rotITSspdShealdVVt1);
-    Mv->AddNode(Dwv,3,rotITSspdShealdVVt2);
-    Mv->AddNode(Dwv,4,rotITSspdShealdVVt3);
-    k=2;
-    for(i=1;i<10;i++) {
-      th = ((Double_t)i)*TSCAngle*kDegree;
-      rot = new TGeoRotation("",0.0,0.0,th);
-      Mv->AddNode(A1v,i+1,rot);
-      Mv->AddNode(B1v,i+2,new TGeoCombiTrans(*tranb,*rot));
-      Mv->AddNode(B1v,i+12,new TGeoCombiTrans(*tranbm,*rot));
-      Mv->AddNode(C1v,i+1,new TGeoCombiTrans(*tranc,*rot));
-      if(i!=0||i!=2||i!=7){
-        Mv->AddNode(A2v,k++,rot);
-        Mv->AddNode(B2v,k++,new TGeoCombiTrans(*tranb,*rot));
-        Mv->AddNode(B2v,k++,new TGeoCombiTrans(*tranbm,*rot));
-        Mv->AddNode(C2v,k++,new TGeoCombiTrans(*tranc,*rot));
-      } // end if
-      if(i==5) {
-        Mv->AddNode(A3v,2,rot);
-        Mv->AddNode(B3v,3,new TGeoCombiTrans(*tranb,*rot));
-        Mv->AddNode(B3v,4,new TGeoCombiTrans(*tranbm,*rot));
-        Mv->AddNode(C3v,2,new TGeoCombiTrans(*tranc,*rot));
-      } // end if
-    } // end for i
-    rot = new TGeoRotation("",180.,0.0,0.0);
-    Mv->AddNode(A3v,3,rot);
-    Mv->AddNode(B3v,5,new TGeoCombiTrans(*tranb,*rot));
-    Mv->AddNode(B3v,6,new TGeoCombiTrans(*tranbm,*rot));
-    Mv->AddNode(C3v,3,new TGeoCombiTrans(*tranc,*rot));
-    rot = new TGeoRotation("",180.,0.0,180.0);
-    Mv->AddNode(A3v,4,rot);
-    Mv->AddNode(B3v,7,new TGeoCombiTrans(*tranb,*rot));
-    Mv->AddNode(B3v,8,new TGeoCombiTrans(*tranbm,*rot));
-    Mv->AddNode(C3v,4,new TGeoCombiTrans(*tranc,*rot));
-    if(GetDebug()){
-        A1v->PrintNodes();
-        Ah1v->PrintNodes();
-        A2v->PrintNodes();
-        Ah2v->PrintNodes();
-        A3v->PrintNodes();
-        Ah3v->PrintNodes();
-        B1v->PrintNodes();
-        Bh1v->PrintNodes();
-        B2v->PrintNodes();
-        Bh2v->PrintNodes();
-        B3v->PrintNodes();
-        Bh3v->PrintNodes();
-        C1v->PrintNodes();
-        Ch1v->PrintNodes();
-        C2v->PrintNodes();
-        Ch2v->PrintNodes();
-        C3v->PrintNodes();
-        Ch3v->PrintNodes();
-        Dv->PrintNodes();
-        Dsv->PrintNodes();
-        Dwv->PrintNodes();
-        Dwsv->PrintNodes();
-        //Mv->PrintNodes();
-    } // end if
-}
-//______________________________________________________________________
-void AliITSv11::SDDCone(TGeoVolume *Moth){
-    // Define the detail SDD support cone geometry.
-    // Inputs:
     //   none.
-    // Outputs:
-    //  none.
     // Return:
-    //  none.
-    //
-    // From Cilindro Centrale - Lavorazioni, ALR 0816/1 04/08/03 File
-    // name SDD/Cilindro.hpgl
-    const Double_t TSLength       = 790.0*kmm; // Thermal Sheeld length
-    const Double_t TSInsertoLength= 15.0*kmm;    // ????
-    const Double_t TSOuterR       = 0.5*(220.+10.)*kmm; // ????
-    const Double_t TSInnerR       = 0.5*(220.-10.)*kmm; // ????
-    const Double_t TSCarbonFiberth= 0.02*kmm;     // ????
-    const Double_t TSBoltDiameter = 6.0*kmm; // M6 screw
-    const Double_t TSBoltDepth    = 6.0*kmm; // in volume C
-    const Double_t TSBoltRadius   = 0.5*220.*kmm; // Radius in volume C
-    const Double_t TSBoltAngle0   = 0.0*kDegree; // Angle in volume C
-    const Double_t TSBoltdAngle   = 30.0*kDegree; // Angle in Volume C
-    Double_t x,y,z,t,t0;
-    Int_t i,n;
-    TGeoTube *A,*B,*C,*D;
-    TGeoTranslation *tran;
-    TGeoRotation *rot;
-    TGeoCombiTrans *rotran;
-    TGeoMedium *SDDcf,*SDDfs,*SDDfo,*SDDss;
-
-    A = new TGeoTube("ITS SDD Central Cylinder",TSInnerR,TSOuterR,.5*TSLength);
-    B = new TGeoTube("ITS SDD CC Foam",TSInnerR+TSCarbonFiberth,
-                    TSOuterR-TSCarbonFiberth,
-                    0.5*(TSLength-2.0*TSInsertoLength));
-    C = new TGeoTube("ITS SDD CC Inserto",TSInnerR+TSCarbonFiberth,
-                    TSOuterR-TSCarbonFiberth,0.5*TSLength);
-    D = new TGeoTube("ITS SDD CC M6 bolt end",0.0,0.5*TSBoltDiameter,
-                    0.5*TSBoltDepth);
-    printTube(A);
-    printTube(B);
-    printTube(C);
-    printTube(D);
-    //
-    TGeoManager *mgr = gGeoManager;
-    SDDcf = mgr->GetMedium("ITSssdCarbonFiber");
-    SDDfs = mgr->GetMedium("ITSssdStaselite4411w");
-    SDDfo = mgr->GetMedium("ITSssdRohacell50A");
-    SDDss = mgr->GetMedium("ITSssdStainlessSteal");
-    TGeoVolume *Av,*Bv,*Cv,*Dv;
-    Av = new TGeoVolume("ITSsddCentCylCF",A,SDDcf);
-    Av->SetVisibility(kTRUE);
-    Av->SetLineColor(4);
-    Av->SetLineWidth(1);
-    Av->SetFillColor(Av->GetLineColor());
-    Av->SetFillStyle(4000); // 0% transparent
-    Bv = new TGeoVolume("ITSsddCentCylF",B,SDDfo);
-    Bv->SetVisibility(kTRUE);
-    Bv->SetLineColor(3);
-    Bv->SetLineWidth(1);
-    Bv->SetFillColor(Bv->GetLineColor());
-    Bv->SetFillStyle(4000); // 0% transparent
-    Cv = new TGeoVolume("ITSsddCentCylSt",C,SDDfs);
-    Cv->SetVisibility(kTRUE);
-    Cv->SetLineColor(2);
-    Cv->SetLineWidth(1);
-    Cv->SetFillColor(Cv->GetLineColor());
-    Cv->SetFillStyle(4000); // 0% transparent
-    Dv = new TGeoVolume("ITSsddCentCylSS",D,SDDss);
-    Dv->SetVisibility(kTRUE);
-    Dv->SetLineColor(1);
-    Dv->SetLineWidth(1);
-    Dv->SetFillColor(Dv->GetLineColor());
-    Dv->SetFillStyle(4000); // 0% transparent
-    //
-    Moth->AddNode(Av,1,0);
-    Av->AddNode(Cv,1,0);
-    Cv->AddNode(Bv,1,0);
-    n = (Int_t)((360.*kDegree)/TSBoltdAngle);
-    for(i=0;i<n;i++){
-        t = TSBoltAngle0+((Double_t)i)*TSBoltdAngle;
-        x = TSBoltRadius*TMath::Cos(t*kRadian);
-        y = TSBoltRadius*TMath::Sin(t*kRadian);
-        z = 0.5*(TSLength-TSBoltDepth);
-        tran = new TGeoTranslation("",x,y,z);
-        Cv->AddNode(Dv,i+1,tran);
-        tran = new TGeoTranslation("",x,y,-z);
-        Cv->AddNode(Dv,i+n+1,tran);
-    } // end for i
-    if(GetDebug()){
-        Av->PrintNodes();
-        Bv->PrintNodes();
-        Cv->PrintNodes();
-        Dv->PrintNodes();
-    } // end if
-    // SDD Suport Cone
-    //
-    //
-    const Double_t Thickness = 10.5*kmm; // Thickness of Rohacell+carbon fiber
-    const Double_t Cthick    = 1.5*kmm; // Carbon finber thickness
-    const Double_t Rcurv     = 15.0*kmm; // Radius of curvature.
-    const Double_t Tc        = 45.0; // angle of SSD cone [degrees].
-    const Double_t Sintc = TMath::Sin(Tc*TMath::DegToRad());
-    const Double_t Costc = TMath::Cos(Tc*TMath::DegToRad());
-    const Double_t Tantc = TMath::Tan(Tc*TMath::DegToRad());
-    const Double_t ZouterMilled = 23.0*kmm;
-    const Double_t Zcylinder    = 186.0*kmm;
-    const Double_t Z0           = Zcylinder + 0.5*TSLength;
-    //const Int_t Nspoaks         = 12;
-    //const Int_t Nmounts         = 4;
-    //const Double_t DmountAngle  = 9.0; // degrees
-    const Double_t RoutMax      = 0.5*560.0*kmm;
-    const Double_t RoutMin      = 0.5*539.0*kmm;
-    // Holes in cone for cables
-    const Double_t PhiHole1     = 0.0*kDegree;
-    const Double_t dPhiHole1    = 25.0*kDegree;
-    const Double_t RholeMax1    = 0.5*528.*kmm;
-    const Double_t RholeMin1    = 0.5*464.*kmm;
-    const Double_t PhiHole2     = 0.0*kDegree;
-    const Double_t dPhiHole2    = 50.0*kDegree;
-    const Double_t RholeMax2    = 0.5*375.*kmm;
-    const Double_t RholeMin2    = 0.5*280.*kmm;
-    //
-    //const Int_t NpostsOut       = 6;
-    //const Int_t NpostsIn        = 3;
-    //const Double_t Phi0PostOut  = 0.0; // degree
-    //const Double_t Phi0PostIn   = 0.0; // degree
-    //const Double_t dRpostOut    = 16.0*kmm;
-    //const Double_t dRpostIn     = 16.0*kmm;
-    //const Double_t ZpostMaxOut  = 116.0*kmm;
-    //const Double_t ZpostMaxIn   = 190.0*kmm;
-    const Double_t RinMax       = 0.5*216*kmm;
-    const Double_t RinCylinder  = 0.5*231.0*kmm;
-    //const Double_t RinHole      = 0.5*220.0*kmm;
-    const Double_t RinMin       = 0.5*210.0*kmm;
-    const Double_t dZin         = 15.0*kmm; // ???
-    //
-    Double_t dza = Thickness/Sintc-(RoutMax-RoutMin)/Tantc;
-    Double_t Z,Rmin,Rmax; // Temp variables.
-    if(dza<=0){ // The number or order of the points are in error for a proper
-     // call to pcons!
-     Error("SDDcone","The definition of the points for a call to PCONS is"
-           " in error. abort.");
-     return;
-    } // end if
-    TGeoPcon *E = new TGeoPcon("ITSsddSuportConeCarbonFiberSurfaceE",
-                               0.0,360.0,12);
-    E->Z(0)    = 0.0;
-    E->Rmin(0) = RoutMin;
-    E->Rmax(0) = RoutMax;
-    E->Z(1)    = ZouterMilled - dza;
-    E->Rmin(1) = E->GetRmin(0);
-    E->Rmax(1) = E->GetRmax(0);
-    E->Z(2)    = ZouterMilled;
-    E->Rmax(2) = E->GetRmax(0);
-    RadiusOfCurvature(Rcurv,0.,E->GetZ(1),E->GetRmin(1),Tc,Z,Rmin);
-    E->Z(3)    = Z;
-    E->Rmin(3) = Rmin;
-    E->Rmin(2) = RminFrom2Points(E,3,1,E->GetZ(2));
-    RadiusOfCurvature(Rcurv,0.,E->GetZ(2),E->GetRmax(2),Tc,Z,Rmax);
-    E->Z(4)    = Z;
-    E->Rmax(4) = Rmax;
-    E->Rmin(4) = RminFromZpCone(E,Tc,E->GetZ(4),0.0);
-    E->Rmax(3) = RmaxFrom2Points(E,4,2,E->GetZ(3));
-    E->Rmin(7) = RinMin;
-    E->Rmin(8) = RinMin;
-    RadiusOfCurvature(Rcurv,90.0,0.0,RinMax,90.0-Tc,Z,Rmax);
-    E->Rmax(8) = Rmax;
-    E->Z(8)    = ZFromRmaxpCone(E,Tc,E->GetRmax(8));
-    E->Z(9)    = Zcylinder;
-    E->Rmin(9) = RinMin;
-    E->Z(10)    = E->GetZ(9);
-    E->Rmin(10) = RinCylinder;
-    E->Rmin(11) = RinCylinder;
-    E->Rmax(11) = E->GetRmin(11);
-    Rmin        = E->GetRmin(8);
-    RadiusOfCurvature(Rcurv,90.0-Tc,E->GetZ(8),E->GetRmax(8),90.0,Z,Rmax);
-    Rmax = RinMax;
-    E->Z(11)    = Z+(E->GetZ(8)-Z)*(E->GetRmax(11)-Rmax)/(E->GetRmax(8)-Rmax);
-    E->Rmax(9) = RmaxFrom2Points(E,11,8,E->GetZ(9));
-    E->Rmax(10) = E->GetRmax(9);
-    E->Z(6)    = Z-dZin;
-    E->Z(7)    = E->GetZ(6);
-    E->Rmax(6) = RmaxFromZpCone(E,Tc,E->GetZ(6));
-    E->Rmax(7) = E->GetRmax(6);
-    RadiusOfCurvature(Rcurv,90.,E->GetZ(6),0.0,90.0-Tc,Z,Rmin);
-    E->Z(5)    = Z;
-    E->Rmin(5) = RminFromZpCone(E,Tc,Z);
-    E->Rmax(5) = RmaxFromZpCone(E,Tc,Z);
-    RadiusOfCurvature(Rcurv,90.-Tc,0.0,E->Rmin(5),90.0,Z,Rmin);
-    E->Rmin(6) = Rmin;
-    printPcon(E);
-    // Inner Core, Inserto material
-    TGeoPcon *F = new TGeoPcon("ITSsddSuportConeInsertoStesaliteF",0.,360.0,9);
-    F->Z(0)    = E->GetZ(0);
-    F->Rmin(0) = E->GetRmin(0)+Cthick;
-    F->Rmax(0) = E->GetRmax(0)-Cthick;
-    F->Z(1)    = E->GetZ(1);
-    F->Rmin(1) = F->GetRmin(0);
-    F->Rmax(1) = F->GetRmax(0);
-    F->Z(2)    = E->GetZ(2);
-    F->Rmax(2) = F->GetRmax(1);
-    RadiusOfCurvature(Rcurv-Cthick,0.,F->GetZ(1),F->GetRmax(1),Tc,Z,Rmin);
-    F->Z(3)    = Z;
-    F->Rmin(3) = Rmin;
-    F->Rmin(2) = RminFrom2Points(F,3,1,F->GetZ(2));
-    RadiusOfCurvature(Rcurv+Cthick,0.,F->GetZ(2),F->GetRmax(2),Tc,Z,Rmax);
-    F->Z(4)    = Z;
-    F->Rmax(4) = Rmax;
-    F->Rmin(4) = RmaxFromZpCone(E,Tc,F->GetZ(4),-Cthick);
-    F->Rmax(3) = RmaxFrom2Points(F,4,2,F->GetZ(3));
-    F->Rmin(7) = E->GetRmin(7);
-    F->Rmin(8) = E->GetRmin(8);
-    F->Z(6)    = E->GetZ(6)+Cthick;
-    F->Rmin(6) = E->GetRmin(6);
-    F->Z(7)    = F->GetZ(6);
-    F->Rmax(8) = E->GetRmax(8)-Cthick*Sintc;
-    RadiusOfCurvature(Rcurv+Cthick,90.,F->GetZ(6),F->GetRmin(6),90.-Tc,Z,Rmin);
-    F->Z(5)    = Z;
-    F->Rmin(5) = Rmin;
-    F->Rmax(5) = RmaxFromZpCone(F,Tc,Z);
-    F->Rmax(6) = RmaxFromZpCone(F,Tc,F->GetZ(6));
-    F->Rmax(7) = F->GetRmax(6);
-    F->Z(8)    = ZFromRmaxpCone(F,Tc,F->GetRmax(8),-Cthick);
-    printPcon(F);
-    // Inner Core, Inserto material
-    TGeoPcon *G = new TGeoPcon("ITSsddSuportConeFoamCoreG",0.0,360.0,4);
-    RadiusOfCurvature(Rcurv+Cthick,0.0,F->GetZ(1),F->GetRmin(1),Tc,Z,Rmin);
-    G->Z(0)    = Z;
-    G->Rmin(0) = Rmin;
-    G->Rmax(0) = G->GetRmin(0);
-    G->Z(1)    = G->GetZ(0)+(Thickness-2.0*Cthick)/Sintc;;
-    G->Rmin(1) = RminFromZpCone(F,Tc,G->GetZ(1));
-    G->Rmax(1) = RmaxFromZpCone(F,Tc,G->GetZ(1));
-    G->Z(2)    = E->GetZ(5)-Cthick;
-    G->Rmin(2) = RminFromZpCone(F,Tc,G->GetZ(2));
-    G->Rmax(2) = RmaxFromZpCone(F,Tc,G->GetZ(2));
-    G->Z(3)    = F->GetZ(5)+(Thickness-2.0*Cthick)*Costc;
-    G->Rmax(3) = RmaxFromZpCone(F,Tc,G->GetZ(3));
-    G->Rmin(3) = G->GetRmax(3);
-    printPcon(G);
-    //
-    TGeoPcon *H = new TGeoPcon("ITSsddSuportConeHoleH",PhiHole1,dPhiHole1,4);
-    H->Rmin(0) = RholeMax1;
-    H->Rmax(0) = H->GetRmin(0);
-    H->Z(0)    = ZFromRminpCone(E,Tc,H->GetRmin(0));
-    H->Rmax(1) = H->GetRmax(0);
-    H->Z(1)    = ZFromRmaxpCone(E,Tc,H->GetRmax(1));
-    H->Rmin(1) = RminFromZpCone(E,Tc,H->GetZ(1));
-    H->Rmin(2) = RholeMin1;
-    H->Z(2)    = ZFromRminpCone(E,Tc,H->GetRmin(2));
-    H->Rmax(2) = RmaxFromZpCone(E,Tc,H->GetZ(2));
-    H->Rmin(3) = H->GetRmin(2);
-    H->Rmax(3) = H->GetRmin(3);
-    H->Z(3)    = ZFromRminpCone(E,Tc,H->GetRmin(3));
-    printPcon(H);
-    //
-    x = Cthick/(0.5*(RholeMax1+RholeMin1));
-    t0 = PhiHole1 - x/kRadian;
-    t  = dPhiHole1 + 2.0*x/kRadian;
-    TGeoPcon *I = new TGeoPcon("ITSsddSuportConeHoleI",t0,t,4);
-    I->Rmin(0) = RholeMax1+Cthick;
-    I->Rmax(0) = I->GetRmin(0);
-    I->Z(0)    = ZFromRminpCone(F,Tc,I->GetRmin(0));
-    I->Rmax(1) = I->GetRmax(0);
-    I->Z(1)    = ZFromRmaxpCone(F,Tc,I->GetRmax(1));
-    I->Rmin(1) = RminFromZpCone(F,Tc,I->GetZ(1));
-    I->Rmin(2) = RholeMin1-Cthick;
-    I->Z(2)    = ZFromRminpCone(F,Tc,I->GetRmin(2));
-    I->Rmax(2) = RmaxFromZpCone(F,Tc,I->GetZ(2));
-    I->Rmin(3) = I->GetRmin(2);
-    I->Rmax(3) = I->GetRmin(3);
-    I->Z(3)    = ZFromRmaxpCone(F,Tc,I->GetRmax(3));
-    printPcon(I);
-    //
-    TGeoPcon *J = new TGeoPcon("ITSsddSuportConeHoleJ",PhiHole2,dPhiHole2,4);
-    J->Rmin(0) = RholeMax2;
-    J->Rmax(0) = J->GetRmin(0);
-    J->Z(0)    = ZFromRminpCone(E,Tc,J->GetRmin(0));
-    J->Rmax(1) = J->GetRmax(0);
-    J->Z(1)    = ZFromRmaxpCone(E,Tc,J->GetRmax(1));
-    J->Rmin(1) = RminFromZpCone(E,Tc,J->GetZ(1));
-    J->Rmin(2) = RholeMin2;
-    J->Z(2)    = ZFromRminpCone(E,Tc,J->GetRmin(2));
-    J->Rmax(2) = RmaxFromZpCone(E,Tc,J->GetZ(2));
-    J->Rmin(3) = J->GetRmin(2);
-    J->Rmax(3) = J->GetRmin(3);
-    J->Z(3)    = ZFromRmaxpCone(E,Tc,J->GetRmax(3));
-    printPcon(J);
-    //
-    x = Cthick/(0.5*(RholeMax2+RholeMin2));
-    t0 = PhiHole2 - x/kRadian;
-    t  = dPhiHole2 + 2.0*x/kRadian;
-    TGeoPcon *K = new TGeoPcon("ITSsddSuportConeHoleK",t0,t,4);
-    K->Rmin(0) = RholeMax2+Cthick;
-    K->Rmax(0) = K->GetRmin(0);
-    K->Z(0)    = ZFromRminpCone(F,Tc,K->GetRmin(0));
-    K->Rmax(1) = K->GetRmax(0);
-    K->Z(1)    = ZFromRmaxpCone(F,Tc,K->GetRmax(1));
-    K->Rmin(1) = RminFromZpCone(F,Tc,K->GetZ(1));
-    K->Rmin(2) = RholeMin2-Cthick;
-    K->Z(2)    = ZFromRminpCone(F,Tc,K->GetRmin(2));
-    K->Rmax(2) = RmaxFromZpCone(F,Tc,K->GetZ(2));
-    K->Rmin(3) = K->GetRmin(2);
-    K->Rmax(3) = K->GetRmin(3);
-    K->Z(3)    = ZFromRmaxpCone(F,Tc,K->GetRmax(3));
-    printPcon(K);
-    //
-    TGeoCompositeShape *L,*M,*N;
-    rot = new TGeoRotation("ITSsddRotZ30",0.0,0.0,30.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ60",0.0,0.0,60.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ90",0.0,0.0,90.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ120",0.0,0.0,120.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ150",0.0,0.0,150.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ180",0.0,0.0,180.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ210",0.0,0.0,210.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ240",0.0,0.0,240.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ270",0.0,0.0,270.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ300",0.0,0.0,300.0);
-    rot->RegisterYourself();
-    rot = new TGeoRotation("ITSsddRotZ330",0.0,0.0,330.0);
-    rot->RegisterYourself();
-    L = new TGeoCompositeShape("ITS SDD Suport Cone","((((((((((((((((("
-                               "ITSsddSuportConeCarbonFiberSurfaceE -"
-                               "ITSsddSuportConeHoleH)  -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ30) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ60) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ90) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ120) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ150) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ180) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ210) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ240) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ270) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ300) -"
-                               "ITSsddSuportConeHoleH:ITSsddRotZ330) -"
-                               "ITSsddSuportConeHoleJ)  -"
-                               "ITSsddSuportConeHoleJ:ITSsddRotZ60) -"
-                               "ITSsddSuportConeHoleJ:ITSsddRotZ120) -"
-                               "ITSsddSuportConeHoleJ:ITSsddRotZ180) -"
-                               "ITSsddSuportConeHoleJ:ITSsddRotZ240) -"
-                               "ITSsddSuportConeHoleJ:ITSsddRotZ300");
-    M = new TGeoCompositeShape("ITS SDD Suport Cone Inserto Stesalite",
-                               "((((((((((((((((("
-                               "ITSsddSuportConeInsertoStesaliteF -"
-                               "ITSsddSuportConeHoleI)  -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ30) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ60) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ90) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ120) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ150) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ180) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ210) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ240) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ270) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ300) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ330) -"
-                               "ITSsddSuportConeHoleK)  -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ60) -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ120) -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ180) -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ240) -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ300");
-    N = new TGeoCompositeShape("ITS SDD Suport Cone Foam Core",
-                               "((((((((((((((((("
-                               "ITSsddSuportConeFoamCoreG -"
-                               "ITSsddSuportConeHoleI)  -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ30) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ60) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ90) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ120) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ150) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ180) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ210) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ240) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ270) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ300) -"
-                               "ITSsddSuportConeHoleI:ITSsddRotZ330) -"
-                               "ITSsddSuportConeHoleK)  -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ60) -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ120) -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ180) -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ240) -"
-                               "ITSsddSuportConeHoleK:ITSsddRotZ300");
-    //++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
-    TGeoVolume *Lv,*Mv,*Nv;
-    Lv = new TGeoVolume("ITSsddConeL",L,SDDcf);
-    Lv->SetVisibility(kTRUE);
-    Lv->SetLineColor(4);
-    Lv->SetLineWidth(1);
-    Lv->SetFillColor(Lv->GetLineColor());
-    Lv->SetFillStyle(4000); // 0% transparent
-    Mv = new TGeoVolume("ITSsddConeM",M,SDDfs);
-    Mv->SetVisibility(kTRUE);
-    Mv->SetLineColor(2);
-    Mv->SetLineWidth(1);
-    Mv->SetFillColor(Mv->GetLineColor());
-    Mv->SetFillStyle(4010); // 10% transparent
-    Nv = new TGeoVolume("ITSsddConeN",N,SDDfo);
-    Nv->SetVisibility(kTRUE);
-    Nv->SetLineColor(7);
-    Nv->SetLineWidth(1);
-    Nv->SetFillColor(Nv->GetLineColor());
-    Nv->SetFillStyle(4050); // 50% transparent
-    //
-    Mv->AddNode(Nv,1,0);
-    Lv->AddNode(Mv,1,0);
-    tran = new TGeoTranslation("",0.0,0.0,-Z0);
-    Moth->AddNode(Lv,1,tran);
-    rot = new TGeoRotation("",0.0,180.0*kDegree,0.0);
-    rotran = new TGeoCombiTrans("",0.0,0.0,Z0,rot);
-    delete rot;// rot not explicity used in AddNode functions.
-    Moth->AddNode(Lv,2,rotran);
-    if(GetDebug()){
-        Lv->PrintNodes();
-        Mv->PrintNodes();
-        Nv->PrintNodes();
-    } // end if
-}
-//______________________________________________________________________
-void AliITSv11::SSDCone(TGeoVolume *Moth){
-    // Define the detail SSD support cone geometry.
-    // Inputs:
     //   none.
-    // Outputs:
-    //  none.
-    // Return:
-    //  none.
-    //
-    TGeoMedium *SSDcf  = 0; // SSD support cone Carbon Fiber materal number.
-    TGeoMedium *SSDfs  = 0; // SSD support cone inserto stesalite 4411w.
-    TGeoMedium *SSDfo  = 0; // SSD support cone foam, Rohacell 50A.
-    TGeoMedium *SSDss  = 0; // SSD support cone screw material,Stainless steal
-    TGeoMedium *SSDair = 0; // SSD support cone Air
-    TGeoMedium *SSDal  = 0; // SSD support cone SDD mounting bracket Al
-    TGeoManager *mgr = gGeoManager;
-    SSDcf = mgr->GetMedium("ITSssdCarbonFiber");
-    SSDfs = mgr->GetMedium("ITSssdStaselite4411w");
-    SSDfo = mgr->GetMedium("ITSssdRohacell50A");
-    SSDss = mgr->GetMedium("ITSssdStainlessSteal");
-    SSDair= mgr->GetMedium("ITSssdAir");
-    SSDal = mgr->GetMedium("ITSssdAl");
-    //
-    // SSD Central cylinder/Thermal Sheald.
-    const Double_t ZThCylinder = 1140.0*kmm; //
-    const Double_t ZThCylFoam  = 1020.0*kmm; //
-    const Double_t RThCylOuter = 0.5*595.0*kmm; //
-    const Double_t CthickThCyl = 0.64*kmm; //
-    const Double_t FoamThickTh = 5.0*kmm; //
-    const Double_t dZThCylThEnd = 6.0*kmm; //
-    const Double_t RThCylInerEnd= 0.5*560.5*kmm; //
-    TGeoPcon *CA,*CB;
-    TGeoTube*CC;
-    //
-    CA = new TGeoPcon("ITS SSD Thermal Centeral CylinderA",0.0,360.0,6);
-    CB = new TGeoPcon("ITS SSD Thermal Centeral CylinderB",0.0,360.0,6);
-    CC = new TGeoTube("ITS SSD Thermal Centeral CylinderC",
-                      RThCylOuter-CthickThCyl-FoamThickTh,
-                      RThCylOuter-CthickThCyl,0.5*ZThCylFoam);
-    CA->Z(0)    = -0.5*ZThCylinder;
-    CA->Rmin(0) = RThCylInerEnd;
-    CA->Rmax(0) = RThCylOuter;
-    CA->Z(1)    = CA->GetZ(0) + dZThCylThEnd;
-    CA->Rmin(1) = CA->GetRmin(0);
-    CA->Rmax(1) = CA->GetRmax(0);
-    CA->Z(2)    = -0.5*ZThCylFoam;
-    CA->Rmin(2) = RThCylOuter - 2.0*CthickThCyl-FoamThickTh;
-    CA->Rmax(2) = CA->GetRmax(0);
-    CA->Z(3)    = -CA->GetZ(2);
-    CA->Rmin(3) = CA->GetRmin(2);
-    CA->Rmax(3) = CA->GetRmax(2);
-    CA->Z(4)    = -CA->GetZ(1);
-    CA->Rmin(4) = CA->GetRmin(1);
-    CA->Rmax(4) = CA->GetRmax(1);
-    CA->Z(5)    = -CA->GetZ(0);
-    CA->Rmin(5) = CA->GetRmin(0);
-    CA->Rmax(5) = CA->GetRmax(0);
-    //
-    CB->Z(0)    = CA->GetZ(0);
-    CB->Rmin(0) = CA->GetRmin(0) + CthickThCyl;
-    CB->Rmax(0) = CA->GetRmax(0) - CthickThCyl;
-    CB->Z(1)    = CA->GetZ(1);
-    CB->Rmin(1) = CA->GetRmin(1) + CthickThCyl;
-    CB->Rmax(1) = CA->GetRmax(1) - CthickThCyl;
-    CB->Z(2)    = CA->GetZ(2);
-    CB->Rmin(2) = CA->GetRmin(2) + CthickThCyl;
-    CB->Rmax(2) = CA->GetRmax(2) - CthickThCyl;
-    CB->Z(3)    = CA->GetZ(3);
-    CB->Rmin(3) = CA->GetRmin(3) + CthickThCyl;
-    CB->Rmax(3) = CA->GetRmax(3) - CthickThCyl;
-    CB->Z(4)    = CA->GetZ(4);
-    CB->Rmin(4) = CA->GetRmin(4) + CthickThCyl;
-    CB->Rmax(4) = CA->GetRmax(4) - CthickThCyl;
-    CB->Z(5)    = CA->GetZ(5);
-    CB->Rmin(5) = CA->GetRmin(5) + CthickThCyl;
-    CB->Rmax(5) = CA->GetRmax(5) - CthickThCyl;
-    //
-    printPcon(CA);
-    printPcon(CB);
-    printTube(CC);
-    TGeoVolume *CAv,*CBv,*CCv;
-    CAv = new TGeoVolume("ITSssdCentCylCA",CA,SSDcf);
-    CAv->SetVisibility(kTRUE);
-    CAv->SetLineColor(4); // blue
-    CAv->SetLineWidth(1);
-    CAv->SetFillColor(CAv->GetLineColor());
-    CAv->SetFillStyle(4010); // 10% transparent
-    CBv = new TGeoVolume("ITSssdCentCylCB",CB,SSDfs);
-    CBv->SetVisibility(kTRUE);
-    CBv->SetLineColor(2); // red
-    CBv->SetLineWidth(1);
-    CBv->SetFillColor(CBv->GetLineColor());
-    CBv->SetFillStyle(4010); // 10% transparent
-    CCv = new TGeoVolume("ITSssdCentCylCC",CC,SSDfo);
-    CCv->SetVisibility(kTRUE);
-    CCv->SetLineColor(3); // green
-    CCv->SetLineWidth(1);
-    CCv->SetFillColor(CCv->GetLineColor());
-    CCv->SetFillStyle(4010); // 10% transparent
-    CBv->AddNode(CCv,1,0);
-    CAv->AddNode(CBv,1,0);
-    Moth->AddNode(CAv,1,0);
-    if(GetDebug()){
-        CAv->PrintNodes();
-        CBv->PrintNodes();
-        CCv->PrintNodes();
-    } // end if
-    //
-    const Double_t Thickness = 13.0*kmm; // Thickness of Rohacell+carbon fiber
-    const Double_t Cthick    = 1.5*kmm; // Carbon finber thickness
-    const Double_t Rcurv     = 15.0*kmm; // Radius of curvature.
-    const Double_t Tc        = 51.0; // angle of SSD cone [degrees].
-    const Double_t Sintc = TMath::Sin(Tc*TMath::DegToRad());
-    const Double_t Costc = TMath::Cos(Tc*TMath::DegToRad());
-    const Double_t Tantc = TMath::Tan(Tc*TMath::DegToRad());
-    const Double_t ZouterMilled = (13.5-5.0)*kmm;
-    const Double_t Zcylinder    = 170.0*kmm;
-    const Double_t Z0           = Zcylinder + 0.5*ZThCylinder;
-    const Int_t Nspoaks         = 12;
-    const Int_t Nmounts         = 4;
-    const Double_t DmountAngle  = 9.0; // degrees
-    const Double_t RoutMax      = 0.5*985.0*kmm;
-    const Double_t RoutHole     = 0.5*965.0*kmm;
-    const Double_t RoutMin      = 0.5*945.0*kmm;
-    const Double_t RholeMax     = 0.5*890.0*kmm;
-    const Double_t RholeMin     = 0.5*740.0*kmm;
-    const Double_t RpostMin     = 316.0*kmm;
-    const Double_t ZpostMax     = 196.0*kmm;
-    const Int_t Nposts          = 6;
-    const Double_t Phi0Post     = 0.0; // degree
-    const Double_t dRpost       = 23.0*kmm;
-    const Double_t RinMax       = 0.5*590.0*kmm;
-    const Double_t RinCylinder  = 0.5*597.0*kmm;
-    const Double_t RinHole      = 0.5*575.0*kmm;
-    const Double_t RinMin       = 0.5*562.0*kmm;
-    const Double_t dZin         = 15.0*kmm;
-    // SSD-SDD Thermal/Mechanical cylinder mounts
-    const Int_t NinScrews          = 40;
-    const Double_t Phi0Screws      = 0.5*360.0/((const Double_t)NinScrews);//d
-    const Double_t RcylinderScrews = 0.5*570.0*kmm;//from older drawing????
-    const Double_t DscrewHead      = 8.0*kmm;
-    const Double_t DscrewShaft     = 4.6*kmm;
-    const Double_t ThScrewHeadHole = 8.5*kmm;
-    // SDD mounting bracket, SSD part
-    const Double_t NssdSupports      = 3;// mounting of U and T
-    const Double_t DssdsddBracketAngle = 9.0; // degrees
-    const Double_t Phi0SDDsupports   = 0.0; // degree
-    const Double_t RsddSupportPlate  = 0.5*585.0*kmm;
-    const Double_t ThSDDsupportPlate = 4.0*kmm;
-    const Double_t WsddSupportPlate  = 70.0*kmm;
-    //
-    // Lets start with the upper left outer carbon fiber surface.
-    // Between za[2],rmaxa[2] and za[4],rmaxa[4] there is a curved section
-    // given by rmaxa = rmaxa[2]-r*Sind(t) for 0<=t<=Tc and 
-    // za = za[2] + r*Cosd(t) for 0<=t<=Tc. Simularly between za[1],rmina[1
-    // and za[3],rmina[3] there is a curve section given by
-    // rmina = rmina[1]-r*Sind(t) for 0<=t<=Tc and za = za[1]+r&Sind(t)
-    // for t<=0<=Tc. These curves have been replaced by straight lines
-    // between the equivelent points for simplicity.
-    Double_t dza = Thickness/Sintc-(RoutMax-RoutMin)/Tantc;
-    Int_t i,j;
-    Double_t x,y,z[9],rn[9],rx[9],phi,dphi;
-    Double_t t,t0,Z,Rmin,Rmax; // Temp variables.
-    if(dza<=0){ // The number or order of the points are in error for a proper
-     // call to pcons!
-     Error("SSDcone","The definition of the points for a call to PCONS is"
-           " in error. abort.");
-     return;
-    } // end if
-    // Poly-cone Volume A. Top part of SSD cone Carbon Fiber.
-    phi   = 0.0;
-    dphi  = 360.0;
-    z[0]  = 0.0;
-    rn[0] = RoutMin;
-    rx[0] = RoutMax;
-    z[1]  = z[0]+ZouterMilled - dza; // za[2] - dza.
-    rn[1] = rn[0];
-    rx[1] = rx[0];
-    z[2]  = z[0]+ZouterMilled;//From Drawing ALR-0767 and ALR-0767/3
-    rx[2] = rx[0];
-    RadiusOfCurvature(Rcurv,0.,z[1],rn[1],Tc,z[3],rn[3]);
-    rn[2] = RFrom2Points(rn,z,3,1,z[2]);
-    RadiusOfCurvature(Rcurv,0.,z[2],rx[2],Tc,z[4],rx[4]);
-    rn[4] = RminFromZpCone(rn,z,Tc,z[4]);
-    rx[3] = RFrom2Points(rx,z,4,2,z[3]);
-    rn[5] = RholeMax;
-    z[5]  = Zfrom2Points(z,rn,4,3,rn[5]);
-    rx[5] = RmaxFromZpCone(rx,z,Tc,z[5]);
-    rn[6] = RholeMax;
-    rx[6] = rn[6];
-    z[6]  = ZFromRmaxpCone(rx,z,Tc,rx[6]);
-    TGeoPcon *A = new TGeoPcon("ITS SSD Suport cone Carbon Fiber "
-                       "Surface outer left",phi,dphi,7);
-    for(i=0;i<A->GetNz();i++){
-        A->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(A);
-    //
-    // Poly-cone Volume B. Stesalite inside volume A.
-    // Now lets define the Inserto Stesalite 4411w material volume.
-    phi   = 0.0;
-    dphi  = 360.0;
-    z[0]  = A->GetZ(0);
-    rn[0] = A->GetRmin(0)+Cthick;
-    rx[0] = A->GetRmax(0)-Cthick;
-    z[1]  = A->GetZ(1);
-    rn[1] = rn[0];
-    rx[1] = rx[0];
-    z[2]  = A->GetZ(2);
-    rx[2] = rx[1];
-    RadiusOfCurvature(Rcurv-Cthick,0.,z[2],rx[2],Tc,z[3],rx[3]);
-    RadiusOfCurvature(Rcurv+Cthick,0.,z[1],rn[1],Tc,z[4],rn[4]);
-    rn[2] = RFrom2Points(rn,z,4,1,z[2]);
-    rn[3] = RFrom2Points(rn,z,4,1,z[3]);
-    z[5]  = z[4]+(Thickness-2.0*Cthick)/Sintc;
-    rn[5] = RmaxFromZpCone(A,Tc,z[5],-Cthick);
-    rx[5] = rn[5];
-    rx[4] = RFrom2Points(rx,z,5,3,z[4]);
-    TGeoPcon *B = new TGeoPcon("ITS SSD Suport cone Inserto Stesalite "
-                       "left edge",phi,dphi,6);
-    for(i=0;i<B->GetNz();i++){
-        B->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(B);
-    //
-    // Poly-cone Volume C. Foam inside volume A.
-    // Now lets define the Rohacell foam material volume.
-    phi   = 0.0;
-    dphi  = 360.0;
-    z[0]  = B->GetZ(4);
-    rn[0] = B->GetRmin(4);
-    rx[0] = rn[0];
-    z[1]  = B->GetZ(5);
-    rx[1] = B->GetRmin(5);
-    rn[2] = A->GetRmin(5)+Cthick;//space for carbon fiber covering hole
-    z[2]  = ZFromRminpCone(A,Tc,rn[2],+Cthick);
-    rn[1] = RFrom2Points(rn,z,2,0,z[1]);
-    rx[3] = A->GetRmin(6)+Cthick;
-    rn[3] = rx[3];
-    z[3]  = ZFromRmaxpCone(A,Tc,rx[3],-Cthick);
-    rx[2] = RFrom2Points(rx,z,3,1,z[2]);
-    TGeoPcon *C = new TGeoPcon("ITS SSD Suport cone Rohacell foam "
-                       "left edge",phi,dphi,4);
-    for(i=0;i<C->GetNz();i++){
-        C->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(C);
-    //
-    // In volume SCB, th Inserto Stesalite 4411w material volume, there
-    // are a number of Stainless steel screw and pin studs which will be
-    // filled with screws/studs.
-    rn[0] = 0.0*kmm,rx[0] = 6.0*kmm,z[0] = 0.5*10.0*kmm; // mm
-    TGeoTube *D = new TGeoTube("ITS Screw+stud used to mount things to "
-                       "the SSD support cone",rn[0],rx[0],z[0]);
-    printTube(D);
-    rn[0] = 0.0*kmm;rx[0] = 6.0*kmm;z[0] = 0.5*12.0*kmm; // mm
-    TGeoTube *E = new TGeoTube("ITS pin used to mount things to the "
-                       "SSD support cone",rn[0],rx[0],z[0]);
-    printTube(E);
-    //
-    // Poly-cone Volume F. Foam in spoak reagion, inside volume A.
-    // There is no carbon fiber between this upper left section and the
-    // SSD spoaks. We remove it by replacing it with Rohacell foam.
-    t = Cthick/(0.5*(RholeMax+RholeMin));// It is not posible to get
-    // the carbon fiber thickness uniform in this phi direction. We can only
-    // make it a fixed angular thickness.
-    t *= 180.0/TMath::Pi();
-    phi  = 12.5+t; // degrees see drawing ALR-0767.
-    dphi  = 5.0 - 2.0*t; // degrees
-    z[0]  = C->GetZ(2);
-    rn[0] = C->GetRmin(3);
-    rx[0] = rn[0];
-    rn[1] = A->GetRmin(5);
-    rx[1] = rn[0];
-    z[1]  = ZFromRminpCone(A,Tc,rn[1],+Cthick);
-    z[2]  = C->GetZ(3);
-    rn[2] = rn[1];
-    rx[2] = rx[1];
-    rn[3] = A->GetRmin(6);
-    rx[3] = rn[3];
-    z[3]  = ZFromRmaxpCone(A,Tc,rx[3],-Cthick);
-    TGeoPcon *F = new TGeoPcon("ITS SSD Top Suport cone Rohacell foam "
-                       "Spoak",phi,dphi,4);
-    for(i=0;i<F->GetNz();i++){
-        F->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(F);
-    //=================================================================
-     // Poly-cone Volume G.
-    // Now for the spoak part of the SSD cone.
-    // It is not posible to inclue the radius of curvature between
-    // the spoak part and the upper left part of the SSD cone or lowwer right
-    // part. This would be discribed by the following curves.
-    // R = Rmax - (5mm)*Sin(t) phi = phi0+(5mm*180/(Pi*RoutHole))*Sin(t) 
-    // where 0<=t<=90 For the inner curve a simular equiation holds.
-    phi   = 12.5; // degrees see drawing ALR-0767.
-    dphi  = 5.0; // degrees
-    z[0]  = A->GetZ(5);
-    rn[0] = A->GetRmin(5);
-    rx[0] = rn[0];
-    z[1]  = A->GetZ(6);
-    rn[1] = RminFromZpCone(A,Tc,z[1]);
-    rx[1] = rx[0];
-    rn[2] = RholeMin;
-    z[2]  = ZFromRminpCone(A,Tc,rn[2]);
-    rx[2] = RmaxFromZpCone(A,Tc,z[2]);
-    rn[3] = rn[2];
-    rx[3] = rn[3];
-    z[3]  = ZFromRmaxpCone(A,Tc,rx[3]);
-    TGeoPcon *G = new TGeoPcon("ITS SSD spoak carbon fiber surfaces",
-                       phi,dphi,4);
-    for(i=0;i<G->GetNz();i++){
-        G->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(G);
-    // For the foam core.
-    // Poly-cone Volume H.
-    t = Cthick/(0.5*(RholeMax+RholeMin));// It is not posible to get the
-    // carbon fiber thickness uniform in this phi direction. We can only
-    // make it a fixed angular thickness.
-    t *= 180.0/TMath::Pi();
-    phi   = 12.5+t; // degrees
-    dphi  = 5.0 - 2.0*t; // degrees see drawing ALR-0767.
-    z[0]  = F->GetZ(1);
-    rn[0] = G->GetRmin(0);
-    rx[0] = rn[0];
-    z[1]  = F->GetZ(3);
-    rn[1] = RminFromZpCone(A,Tc,z[1],+Cthick);
-    rx[1] = rx[0];
-    z[2]  = ZFromRminpCone(A,Tc,G->GetRmin(2),+Cthick);
-    rn[2] = G->GetRmin(2);
-    rx[2] = RmaxFromZpCone(A,Tc,z[2],-Cthick);
-    z[3]  = ZFromRmaxpCone(A,Tc,G->GetRmin(3),-Cthick);
-    rn[3] = G->GetRmin(3);
-    rx[3] = rn[3];
-    TGeoPcon *H = new TGeoPcon("ITS SSD support cone Rohacell foam Spoak",
-                       phi,dphi,4); 
-    for(i=0;i<H->GetNz();i++){
-        H->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(H);
-    //
-    //==================================================================
-    // Now for the Inner most part of the SSD cone.
-    //Poly-cone Volume I.
-    phi   = 0.0;
-    dphi  = 360.0;
-    z[0]  = G->GetZ(2);
-    rn[0] = G->GetRmin(2);
-    rx[0] = rn[0];
-    z[1]  = G->GetZ(3);
-    rn[1] = RminFromZpCone(A,Tc,z[1]);
-    rx[1] = rx[0];
-    rn[4] = RinMin;
-    rn[5] = RinMin;
-    RadiusOfCurvature(Rcurv,90.0,0.0,RinMax,90.0-Tc,Z,rx[5]); // z dummy
-    z[5]  = ZFromRmaxpCone(A,Tc,rx[5]);
-    z[6]  = Zcylinder;
-    rn[6] = RinMin;
-    z[7]  = z[6];
-    rn[7] = RinCylinder;
-    rn[8] = RinCylinder;
-    rx[8] = rn[8];
-    Rmin   = rn[5];
-    RadiusOfCurvature(Rcurv,90.0-Tc,z[5],rx[5],90.0,Z,Rmax);
-    Rmax   = RinMax;
-    z[8]  = Z+(z[5]-Z)*(rx[8]-Rmax)/(rx[5]-Rmax);
-    rx[6] = RFrom2Points(rx,z,8,5,z[6]);
-    rx[7] = rx[6];
-    z[3]  = Z-dZin;
-    z[4]  = z[3];
-    rx[3] = RmaxFromZpCone(A,Tc,z[3]);
-    rx[4] = rx[3];
-    //rmin dummy
-    RadiusOfCurvature(Rcurv,90.,z[3],0.,90.-Tc,z[2],Rmin);
-    rn[2] = RminFromZpCone(A,Tc,z[2]);
-    rx[2] = RmaxFromZpCone(A,Tc,z[2]);
-    // z dummy
-    RadiusOfCurvature(Rcurv,90.-Tc,0.0,rn[2],90.0,Z,rn[3]);
-    TGeoPcon *I = new TGeoPcon("ITS SSD lower/inner right part of SSD "
-                       "cone",phi,dphi,9);
-    for(i=0;i<I->GetNz();i++){
-        I->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(I);
-    // Now for Inserto volume at the inner most radius.
-    // Poly-cone Volume K.
-    phi   = 0.0;
-    dphi  = 360.0;
-    z[1]  = I->GetZ(3)+Cthick;
-    rn[1] = I->GetRmin(3);
-    z[2]  = z[1];
-    rn[2] = I->GetRmin(4);
-    rn[3] = rn[2];
-    rn[4] = rn[2];
-    rx[4] = I->GetRmax(5)-Cthick*Sintc;
-    RadiusOfCurvature(Rcurv+Cthick,90.0,z[1],rn[1],90.0-Tc,z[0],rn[0]);
-    rx[0] = rn[0];
-    z[3]  = z[0]+(Thickness-2.0*Cthick)*Costc;;
-    rx[3] = rx[0]+(Thickness-2.0*Cthick)*Sintc;
-    rx[1] = RFrom2Points(rx,z,3,0,z[1]);
-    rx[2] = rx[1];
-    z[4]  = ZFromRmaxpCone(A,Tc,rx[4],-Cthick);
-    rn[5] = rn[2];
-    z[5]  = I->GetZ(6);
-    rx[5] = (I->GetRmax(5)-I->GetRmax(8))/(I->GetZ(5)-I->GetZ(8))*(z[5]-z[4])+
-          rx[4];
-    TGeoPcon *K = new TGeoPcon("ITS SSD inner most inserto material",
-                       phi,dphi,6);
-    for(i=0;i<K->GetNz();i++){
-        K->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(K);
-    // Now for foam core at the inner most radius.
-    // Poly-cone Volume J.
-    phi   = 0.0;
-    dphi  = 360.0;
-    rn[0] = I->GetRmin(0)-Cthick;
-    z[0]  = ZFromRminpCone(A,Tc,rn[0],+Cthick);
-    rx[0] = rn[0];
-    rx[1] = rx[0];
-    z[1]  = ZFromRmaxpCone(A,Tc,rx[1],-Cthick);
-    rn[1] = RminFromZpCone(A,Tc,z[1],+Cthick);
-    z[2]  = K->GetZ(0);
-    rn[2] = K->GetRmin(0);
-    rx[2] = RmaxFromZpCone(A,Tc,z[2],-Cthick);
-    z[3]  = K->GetZ(3);
-    rn[3] = K->GetRmax(3);
-    rx[3] = rn[3];
-    TGeoPcon *J = new TGeoPcon("ITS SSD inner most foam core",phi,dphi,4); 
-    for(i=0;i<J->GetNz();i++){
-        J->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(J);
-    // Now for foam core at the top of the inner most radius where 
-    // the spoaks are.
-    t = Cthick/(0.5*(RholeMax+RholeMin));// It is not posible to get the
-    // carbon fiber thickness uniform in this phi direction. We can only
-    // make it a fixed angular thickness.
-    // Poly-cone Volume L.
-    t *= 180.0/TMath::Pi();
-    phi   = 12.5+t; // degrees
-    dphi  = 5.0 - 2.0*t; // degrees see drawing ALR-0767.
-    z[0]  = H->GetZ(2);
-    rn[0] = H->GetRmin(2);
-    rx[0] = rn[0];
-    z[1]  = J->GetZ(0);
-    rn[1] = J->GetRmin(0);
-    rx[1] = I->GetRmax(1);
-    z[2]  = H->GetZ(3);
-    rn[2] = rn[1];
-    rx[2] = rx[1];
-    z[3]  = J->GetZ(1);
-    rn[3] = rn[2];
-    rx[3] = rn[3];
-    TGeoPcon *L = new TGeoPcon("ITS SSD Bottom cone Rohacell foam Spoak",
-                       phi,dphi,4);
-    for(i=0;i<L->GetNz();i++){
-        L->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(L);
-    // Now for the SSD mounting posts
-    // Poly-cone Volume O.
-    dphi  = 180.0*dRpost/(RpostMin+0.5*dRpost)/TMath::Pi(); //
-    phi   = Phi0Post-0.5*dphi; // degrees
-    rn[0] = RpostMin+dRpost;
-    rx[0] = rn[0];
-    z[0]  = ZFromRmaxpCone(A,Tc,rx[0]);
-    rn[1] = RpostMin;
-    z[1]  = ZFromRmaxpCone(A,Tc,rn[1]);
-    rx[1] = rx[0];
-    z[2]  = ZpostMax;
-    rn[2] = RpostMin;
-    rx[2] = rn[2]+dRpost;
-    TGeoPcon *O = new TGeoPcon("ITS SSD mounting post, carbon fiber",
-                       phi,dphi,3);
-    for(i=0;i<O->GetNz();i++){
-        O->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(O);
-    // Now for the SSD mounting posts
-    // Poly-cone Volume P.
-    t = 180.0*Cthick/(RpostMin+0.5*dRpost)/TMath::Pi();
-    dphi  = O->GetDphi()-2.0*t; // degrees
-    phi   = O->GetPhi1()+t; //
-    rn[0] = O->GetRmin(0)-Cthick;
-    rx[0] = rn[0];
-    z[0]  = ZFromRmaxpCone(A,Tc,rx[0]);
-    rn[1] = O->GetRmin(1)+Cthick;
-    rx[1] = O->GetRmin(0)-Cthick;
-    z[1]  = ZFromRmaxpCone(A,Tc,rn[1]);
-    rn[2] = rn[1];
-    rx[2] = rx[1];
-    z[2]  = ZpostMax;
-    TGeoPcon *P = new TGeoPcon("ITS SSD mounting post, Inserto",
-                       phi,dphi,3);
-    for(i=0;i<P->GetNz();i++){
-        P->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(P);
-    // This insrto continues into the SSD cone displacing the foam
-    // and the carbon fiber surface at those points where the posts are.
-    //Poly-cone Vol. M
-    phi   = P->GetPhi1();
-    dphi  = P->GetDphi();
-    rn[0] = RpostMin+dRpost-Cthick;
-    rx[0] = rn[0];
-    z[0]  = ZFromRminpCone(A,Tc,rn[0],+Cthick);
-    rx[1] = rx[0];
-    z[1]  = ZFromRmaxpCone(A,Tc,rx[1],-Cthick);
-    rn[1] = RminFromZpCone(A,Tc,z[1],+Cthick);
-    rn[2] = RpostMin+Cthick;
-    z[2]  = ZFromRminpCone(A,Tc,rn[2],+Cthick);
-    rx[2] = RmaxFromZpCone(A,Tc,z[2],-Cthick);
-    rn[3] = rn[2];
-    rx[3] = rn[3];
-    z[3]  = ZFromRmaxpCone(A,Tc,rx[3],-Cthick);
-    TGeoPcon *M = new TGeoPcon("ITS SSD mounting post foam substitute, "
-                       "Inserto",phi,dphi,4);
-    for(i=0;i<M->GetNz();i++){
-        M->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(M);
-    //
-    //Poly-cone Vol. N
-    phi   = P->GetPhi1();
-    dphi  = P->GetDphi();
-    z[0]  = M->GetZ(1);
-    rn[0] = M->GetRmax(1);
-    rx[0] = rn[0];
-    rx[1] = rx[0];
-    z[1]  = ZFromRmaxpCone(A,Tc,rx[1]);
-    rn[1] = RmaxFromZpCone(A,Tc,z[1],-Cthick);
-    z[2]  = M->GetZ(3);
-    rn[2] = M->GetRmin(3);
-    rx[2] = RmaxFromZpCone(A,Tc,z[2]);
-    rn[3] = rn[2];
-    rx[3] = rn[3];
-    z[3]  = ZFromRmaxpCone(A,Tc,rx[3]);
-    TGeoPcon *N = new TGeoPcon("ITS SSD mounting post CF subsititute, "
-                       "Inserto",phi,dphi,4);
-    for(i=0;i<N->GetNz();i++){ 
-        N->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(N);
-    // Bolt heads holding the SSD-SDD tube to the SSD cone.
-    // Bolt -- PolyCone
-    //Poly-cone Volume Q.
-    phi   = 0.0;
-    dphi  = 360.0;
-    z[0]  = I->GetZ(4)+ThSDDsupportPlate;
-    rn[0] = 0.0;
-    rx[0] = 0.5*DscrewHead;
-    z[1]  = I->GetZ(4)+ThScrewHeadHole;
-    rn[1] = 0.0;
-    rx[1] = 0.5*DscrewHead;
-    z[2]  = z[1];
-    rn[2] = 0.0;
-    rx[2] = 0.5*DscrewShaft;
-    z[3]  = I->GetZ(6);
-    rn[3] = 0.0;
-    rx[3] = rx[2];
-    TGeoPcon *Q = new TGeoPcon("ITS SSD Thermal sheal stainless steel "
-                       "bolts",phi,dphi,4);
-    for(i=0;i<Q->GetNz();i++){
-        Q->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(Q);
-    // air infront of bolt (stasolit Volume K) -- Tube
-    z[0]  = 0.5*(ThSDDsupportPlate-Cthick);
-    rn[0] = 0.0*kmm;
-    rx[0] = 0.5*DscrewHead;
-    TGeoTube *R = new TGeoTube("ITS Air in front of bolt (in stasolit)",
-                       rn[0],rx[0],z[0]);
-    // air infront of bolt (carbon fiber volume I) -- Tube
-    z[0]  = 0.5*Cthick;
-    rn[0] = 0.0*kmm;
-    rx[0] = R->GetRmax();
-    TGeoTube *S = new TGeoTube("ITS Air in front of Stainless Steal "
-                       "Screw end, N6",rn[0],rx[0],z[0]);
-    printTube(S);
-    // SDD support plate, SSD side.
-    //Poly-cone Volume T.
-    dphi  = TMath::RadToDeg()*TMath::ATan2(0.5*WsddSupportPlate,
-                                           RsddSupportPlate);
-    phi   = Phi0SDDsupports-0.5*dphi;
-    z[0]  = K->GetZ(2);
-    rn[0] = I->GetRmin(4);
-    rx[0] = RsddSupportPlate;
-    z[1]  = I->GetZ(4) - ThSDDsupportPlate;
-    rn[1] = rn[0];
-    rx[1] = rx[0];
-    TGeoPcon *T = new TGeoPcon("ITS SSD-SDD mounting bracket Inserto->Al.",
-                       phi,dphi,2);
-    for(i=0;i<T->GetNz();i++){
-        T->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(T);
-    //
-    // Poly-cone Volume U.
-    TGeoPcon *U;
-    if(I->GetRmin(3)<T->GetRmax(0)){
-     dphi  = T->GetDphi();
-     phi   = T->GetPhi1();
-     z[2]  = I->GetZ(4);
-     rn[2] = T->GetRmin(0);
-     rx[2] = T->GetRmax(0);
-     z[3]  = K->GetZ(2);
-     rn[3] = rn[2];
-     rx[3] = rx[2];
-     z[1]  = z[2];
-     rn[1] = I->GetRmin(3);
-     rx[1] = rx[3];
-     rx[0] = T->GetRmax(0);
-     rn[0] = rx[0];
-     z[0]  = Zfrom2MinPoints(I,2,3,rn[0]);
-     U = new TGeoPcon("ITS SSD-SDD mounting bracket CF->Al.",phi,dphi,4);
-    }else{
-     dphi  = T->GetDphi();
-     phi   = T->GetPhi1();
-     z[0]  = I->GetZ(4);
-     rn[0] = T->GetRmin(0);
-     rx[0] = T->GetRmax(0);
-     z[1]  = K->GetZ(2);
-     rn[1] = rn[0];
-     rx[1] = rx[0];
-     U = new TGeoPcon("ITS SSD-SDD mounting bracket CF->Al.",phi,dphi,2);
-    }// end if
-    for(i=0;i<U->GetNz();i++){
-        U->DefineSection(i,z[i],rn[i],rx[i]);
-    } // end for i
-    printPcon(U);
-    //
-    TGeoVolume *Av,*Bv,*Cv,*Dv,*Ev,*Fv,*Gv,*Hv,*Iv,*Jv,*Kv,*Lv,*Mv,*Nv,
-            *Ov,*Pv,*Qv,*Rv,*Sv,*Tv,*Uv;
-    Av = new TGeoVolume("ITSssdConeA",A,SSDcf);
-    Av->SetVisibility(kTRUE);
-    Av->SetLineColor(4); // blue
-    Av->SetLineWidth(1);
-    Av->SetFillColor(Av->GetLineColor());
-    Av->SetFillStyle(4010); // 10% transparent
-    Bv = new TGeoVolume("ITSssdConeB",B,SSDfs);
-    Bv->SetVisibility(kTRUE);
-    Bv->SetLineColor(2); // red
-    Bv->SetLineWidth(1);
-    Bv->SetFillColor(Bv->GetLineColor());
-    Bv->SetFillStyle(4010); // 10% transparent
-    Cv = new TGeoVolume("ITSssdConeC",C,SSDfo);
-    Cv->SetVisibility(kTRUE);
-    Cv->SetLineColor(3); // green
-    Cv->SetLineWidth(1);
-    Cv->SetFillColor(Cv->GetLineColor());
-    Cv->SetFillStyle(4010); // 10% transparent
-    Dv = new TGeoVolume("ITSssdConeD",D,SSDss);
-    Dv->SetVisibility(kTRUE);
-    Dv->SetLineColor(1); // black
-    Dv->SetLineWidth(1);
-    Dv->SetFillColor(Dv->GetLineColor());
-    Dv->SetFillStyle(4010); // 10% transparent
-    Ev = new TGeoVolume("ITSssdConeE",E,SSDss);
-    Ev->SetVisibility(kTRUE);
-    Ev->SetLineColor(1); // black
-    Ev->SetLineWidth(1);
-    Ev->SetFillColor(Ev->GetLineColor());
-    Ev->SetFillStyle(4010); // 10% transparent
-    Fv = new TGeoVolume("ITSssdConeF",F,SSDfo);
-    Fv->SetVisibility(kTRUE);
-    Fv->SetLineColor(3); // green
-    Fv->SetLineWidth(1);
-    Fv->SetFillColor(Fv->GetLineColor());
-    Fv->SetFillStyle(4010); // 10% transparent
-    Gv = new TGeoVolume("ITSssdConeG",G,SSDcf);
-    Gv->SetVisibility(kTRUE);
-    Gv->SetLineColor(4); // blue
-    Gv->SetLineWidth(2);
-    Gv->SetFillColor(Gv->GetLineColor());
-    Gv->SetFillStyle(4010); // 10% transparent
-    Hv = new TGeoVolume("ITSssdConeH",H,SSDfo);
-    Hv->SetVisibility(kTRUE);
-    Hv->SetLineColor(3); // green
-    Hv->SetLineWidth(1);
-    Hv->SetFillColor(Hv->GetLineColor());
-    Hv->SetFillStyle(4010); // 10% transparent
-    Iv = new TGeoVolume("ITSssdConeI",I,SSDcf);
-    Iv->SetVisibility(kTRUE);
-    Iv->SetLineColor(4); // blue
-    Iv->SetLineWidth(1);
-    Iv->SetFillColor(Iv->GetLineColor());
-    Iv->SetFillStyle(4010); // 10% transparent
-    Jv = new TGeoVolume("ITSssdConeJ",J,SSDfo);
-    Jv->SetVisibility(kTRUE);
-    Jv->SetLineColor(3); // green
-    Jv->SetLineWidth(3);
-    Jv->SetFillColor(Jv->GetLineColor());
-    Jv->SetFillStyle(4010); // 10% transparent
-    Kv = new TGeoVolume("ITSssdConeK",K,SSDfs);
-    Kv->SetVisibility(kTRUE);
-    Kv->SetLineColor(2); // red
-    Kv->SetLineWidth(1);
-    Kv->SetFillColor(Kv->GetLineColor());
-    Kv->SetFillStyle(4010); // 10% transparent
-    Lv = new TGeoVolume("ITSssdConeL",L,SSDfo);
-    Lv->SetVisibility(kTRUE);
-    Lv->SetLineColor(3); // green
-    Lv->SetLineWidth(3);
-    Lv->SetFillColor(Lv->GetLineColor());
-    Lv->SetFillStyle(4010); // 10% transparent
-    Mv = new TGeoVolume("ITSssdConeM",M,SSDfs);
-    Mv->SetVisibility(kTRUE);
-    Mv->SetLineColor(2); // red
-    Mv->SetLineWidth(1);
-    Mv->SetFillColor(Mv->GetLineColor());
-    Mv->SetFillStyle(4010); // 10% transparent
-    Nv = new TGeoVolume("ITSssdConeN",N,SSDfs);
-    Nv->SetVisibility(kTRUE);
-    Nv->SetLineColor(2); // red
-    Nv->SetLineWidth(1);
-    Nv->SetFillColor(Nv->GetLineColor());
-    Nv->SetFillStyle(4010); // 10% transparent
-    Ov = new TGeoVolume("ITSssdConeO",O,SSDcf);
-    Ov->SetVisibility(kTRUE);
-    Ov->SetLineColor(4); // blue
-    Ov->SetLineWidth(1);
-    Ov->SetFillColor(Iv->GetLineColor());
-    Ov->SetFillStyle(4010); // 10% transparent
-    Pv = new TGeoVolume("ITSssdConeP",P,SSDfs);
-    Pv->SetVisibility(kTRUE);
-    Pv->SetLineColor(2); // red
-    Pv->SetLineWidth(1);
-    Pv->SetFillColor(Pv->GetLineColor());
-    Pv->SetFillStyle(4010); // 10% transparent
-    Qv = new TGeoVolume("ITSssdConeQ",Q,SSDss);
-    Qv->SetVisibility(kTRUE);
-    Qv->SetLineColor(1); // black
-    Qv->SetLineWidth(1);
-    Qv->SetFillColor(Qv->GetLineColor());
-    Qv->SetFillStyle(4010); // 10% transparent
-    Rv = new TGeoVolume("ITSssdConeR",R,SSDair);
-    Rv->SetVisibility(kTRUE);
-    Rv->SetLineColor(5); // yellow
-    Rv->SetLineWidth(1);
-    Rv->SetFillColor(Rv->GetLineColor());
-    Rv->SetFillStyle(4010); // 10% transparent
-    Sv = new TGeoVolume("ITSssdConeS",S,SSDair);
-    Sv->SetVisibility(kTRUE);
-    Sv->SetLineColor(5); // yellow
-    Sv->SetLineWidth(1);
-    Sv->SetFillColor(Sv->GetLineColor());
-    Sv->SetFillStyle(4010); // 10% transparent
-    Tv = new TGeoVolume("ITSssdConeT",T,SSDal);
-    Tv->SetVisibility(kTRUE);
-    Tv->SetLineColor(17); // gray
-    Tv->SetLineWidth(1);
-    Tv->SetFillColor(Tv->GetLineColor());
-    Tv->SetFillStyle(4010); // 10% transparent
-    Uv = new TGeoVolume("ITSssdConeU",U,SSDal);
-    Uv->SetVisibility(kTRUE);
-    Uv->SetLineColor(17); // gray
-    Uv->SetLineWidth(1);
-    Uv->SetFillColor(Uv->GetLineColor());
-    Uv->SetFillStyle(4010); // 10% transparent
-    //
-    TGeoTranslation *tran = new TGeoTranslation("ITSssdConeTrans",0.0,0.0,-Z0);
-    TGeoRotation *rot180  = new TGeoRotation("",0.0,180.0,0.0);
-    TGeoCombiTrans *flip  = new TGeoCombiTrans("ITSssdConeFlip",0.0,0.0,Z0,rot180);
-    delete rot180;// rot not explicity used in AddNode functions.
-    TGeoTranslation *tranR,*tranS;
-    TGeoCombiTrans *fliptran,*rottran;
-    TGeoRotation *rot,*zspoaks,*zspoaks180;
-    Int_t NcD=1,NcE=1,NcQ=1,NcR=1,NcS=1,NcT=1,NcU=1;
-    Av->AddNode(Bv,1,0);
-    Av->AddNode(Cv,1,0);
-    Moth->AddNode(Av,1,tran); // RB24 side
-    Moth->AddNode(Av,2,flip); // RB26 side (Absorber)
-    Moth->AddNode(Iv,1,tran); // RB24 side
-    Moth->AddNode(Iv,2,flip); // RB26 side (Absorber)
-    Gv->AddNode(Hv,1,0);
-    for(i=0;i<Nspoaks;i++){ // SSD Cone Spoaks
-     zspoaks = new TGeoRotation("",0.0,0.0,
-                       ((Double_t)i*360.)/((Double_t)Nspoaks));
-     rottran = new TGeoCombiTrans("",0.0,0.0,-Z0,zspoaks);
-     Moth->AddNode(Gv,i+1,rottran); // RB24 side
-     Av->AddNode(Fv,i+1,zspoaks);
-     Iv->AddNode(Lv,i+1,zspoaks);
-     zspoaks180 =  new TGeoRotation("",0.0,180.0,
-                           ((Double_t)i*360.)/((Double_t)Nspoaks));
-     fliptran = new TGeoCombiTrans("",0.0,0.0,Z0,zspoaks180);
-     delete zspoaks180;// rot not explicity used in AddNode functions.
-     Moth->AddNode(Gv,Nspoaks+i+1,fliptran); // RB26 side
-    } // end for i
-    Iv->AddNode(Jv,1,0);
-    Iv->AddNode(Kv,1,0);
-    Ov->AddNode(Pv,1,0);
-    t0 = (P->GetPhi1()+0.5*P->GetDphi())*kRadian;
-    t  = (0.25* P->GetDphi())*kRadian;
-    z[0] = 0.5*(P->GetRmin(2)+P->GetRmax(2))+
-          0.25*(P->GetRmax(2)-P->GetRmin(2));
-    x = z[0]*TMath::Cos(t0+t);
-    y = z[0]*TMath::Sin(t0+t);
-    tran = new TGeoTranslation("",x,y,P->GetZ(2)-Q->GetZ(3));
-    Pv->AddNode(Qv,NcQ++,tran); // Screw head
-    z[0] = 0.5*(P->GetRmin(2)+P->GetRmax(2))-
-          0.25*(P->GetRmax(2)-P->GetRmin(2));
-    x = z[0]*TMath::Cos(t0-t);
-    y = z[0]*TMath::Sin(t0-t);
-    tran = new TGeoTranslation("",x,y,P->GetZ(2)-Q->GetZ(3));
-    Pv->AddNode(Qv,NcQ++,tran); // Screw head
-    //Pv->AddNode(Vv,1,?); // Air hole in Posts
-    //Pv->AddNode(Vv,2,?); // Air hole in Posts
-    //Mv->AddNode(Wv,1,?); // Air hole in Posts
-    //Mv->AddNode(Wv,2,?); // Air hole in Posts
-    //Nv->AddNode(Xv,1,?); // Air hole in Posts
-    //Nv->AddNode(Xv,2,?); // Air hole in Posts
-    TGeoRotation *zposts,*zposts180;
-    for(i=0;i<Nposts;i++){ // SSD Cone mounting posts
-        zposts = new TGeoRotation("",0.0,0.0,
-                                  ((Double_t)i*360.)/((Double_t)Nposts));
-        rottran = new TGeoCombiTrans("",0.0,0.0,-Z0,zposts);
-        Moth->AddNode(Ov,i+1,rottran); // RB24 side
-        Jv->AddNode(Mv,i+1,zposts);
-        Iv->AddNode(Nv,i+1,zposts);
-        //Jv->AddNode(Xv,2*i+3,?); // Air hole in Posts
-        //Jv->AddNode(Xv,2*i+4,?); // Air hole in Posts
-        zposts180 = new TGeoRotation("",0.0,180.0,
-                                     ((Double_t)i*360.)/((Double_t)Nposts));
-        fliptran = new TGeoCombiTrans("",0.0,0.0,Z0,zposts180);
-        delete zposts180;// rot not explicity used in AddNode functions.
-        Moth->AddNode(Ov,Nposts+i+1,fliptran); // RB26 side
-    } // end for i
-    //
-    for(i=0;i<NinScrews;i++){
-        t = (Phi0Screws+360.*((Double_t)i)/((Double_t)NinScrews))*kRadian;
-        tran= new TGeoTranslation("",RcylinderScrews*TMath::Cos(t),
-                                  RcylinderScrews*TMath::Sin(t),0.0);
-        Kv->AddNode(Qv,NcQ++,tran);
-        tran = new TGeoTranslation("",RcylinderScrews*TMath::Cos(t),
-                                  RcylinderScrews*TMath::Sin(t),
-                                   CB->GetZ(0)+D->GetDz());
-        CBv->AddNode(Dv,NcD++,tran);
-        tran = new TGeoTranslation("",RcylinderScrews*TMath::Cos(t),
-                                  RcylinderScrews*TMath::Sin(t),
-                                   CB->GetZ(5)-D->GetDz());
-        CBv->AddNode(Dv,NcD++,tran);
-        if(/*not where volumes U and T are*/kTRUE){
-            tranR = new TGeoTranslation("",RcylinderScrews*TMath::Cos(t),
-                                        RcylinderScrews*TMath::Sin(t),
-                                        K->GetZ(2)+R->GetDz());
-            tranS = new TGeoTranslation("",RcylinderScrews*TMath::Cos(t),
-                                        RcylinderScrews*TMath::Sin(t),
-                                        I->GetZ(4)+S->GetDz());
-            Kv->AddNode(Rv,NcR++,tranR);
-            Iv->AddNode(Sv,NcS++,tranS);
-        } // end if
-    } // end for i
-    const Int_t Nbscrew=2,Nbpins=3,Nrailsc=4,Nrailp=2;
-    Double_t da[] = {-3.5,-1.5,1.5,3.5};
-    for(i=0;i<2;i++){ // Mounting for ITS-TPC bracket or ITS-Rails
-        t0 = 180.*((Double_t)i)*kRadian;
-        for(j=-Nbscrew/2;j<=Nbscrew/2;j++)if(j!=0){//screws per ITS-TPC bracket
-            t = t0 + 5.0*((Double_t)j)*kRadian;
-            tran = new TGeoTranslation("",RoutHole*TMath::Cos(t),
-                                       RoutHole*TMath::Sin(t),
-                                       B->GetZ(0)+D->GetDz());
-            Bv->AddNode(Dv,NcD++,tran);
-        } // end or j
-        for(j=-Nbpins/2;j<=Nbpins/2;j++){ // pins per ITS-TPC bracket
-            t = t0 + 3.0*((Double_t)j)*kRadian;
-            tran = new TGeoTranslation("",RoutHole*TMath::Cos(t),
-                                       RoutHole*TMath::Sin(t),
-                                       B->GetZ(0)+D->GetDz());
-            Bv->AddNode(Ev,NcE++,tran);
-        } // end or j
-        t0 = (96.5+187.*((Double_t)i))*kRadian;
-        for(j=0;j<Nrailsc;j++){ // screws per ITS-rail bracket
-            t = t0+da[j]*kRadian;
-            tran = new TGeoTranslation("",RoutHole*TMath::Cos(t),
-                                       RoutHole*TMath::Sin(t),
-                                       B->GetZ(0)+D->GetDz());
-            Bv->AddNode(Dv,NcD++,tran);
-        } // end or j
-        t0 = (91.5+184.*((Double_t)i))*kRadian;
-        for(j=-Nrailp/2;j<=Nrailp/2;j++)if(j!=0){ // pins per ITS-rail bracket
-            t = t0+(7.0*((Double_t)j))*kRadian;
-            tran = new TGeoTranslation("",RoutHole*TMath::Cos(t),
-                                       RoutHole*TMath::Sin(t),
-                                       B->GetZ(0)+D->GetDz());
-            Bv->AddNode(Ev,NcE++,tran);
-        } // end or j
-    } // end for i
-    for(i=0;i<Nmounts;i++){ // mounting points for SPD-cone+Beam-pipe support
-        t0 = (45.0+((Double_t)i)*360./((Double_t)Nmounts))*kRadian;
-        for(j=-1;j<=1;j++)if(j!=0){ // 2 screws per bracket
-            t = t0+((Double_t)j)*0.5*DmountAngle*kRadian;
-            tran = new TGeoTranslation("",RoutHole*TMath::Cos(t),
-                                       RoutHole*TMath::Sin(t),
-                                       B->GetZ(0)+D->GetDz());
-            Bv->AddNode(Dv,NcD++,tran);
-        } // end for j
-        for(j=0;j<1;j++){ // 1 pin per bracket
-            t = t0;
-            tran = new TGeoTranslation("",RoutHole*TMath::Cos(t),
-                                       RoutHole*TMath::Sin(t),
-                                       B->GetZ(0)+D->GetDz());
-            Bv->AddNode(Ev,NcE++,tran);
-        } // end for j
-    } // end for i
-    t = (T->GetPhi1()+0.5*T->GetDphi())*kRadian;
-    tran = new TGeoTranslation("",RinHole*TMath::Cos(t),RinHole*TMath::Sin(t),
-                               T->GetZ(T->GetNz()-1)+R->GetDz());
-    Tv->AddNode(Rv,NcR++,tran);
-    t = (U->GetPhi1()+0.5*U->GetDphi())*kRadian;
-    tran = new TGeoTranslation("",RinHole*TMath::Cos(t),RinHole*TMath::Sin(t),
-                               U->GetZ(U->GetNz()-1)+S->GetDz());
-    Uv->AddNode(Sv,NcS++,tran);
-    for(i=0;i<NssdSupports;i++){ // mounting braclets for SSD/SDD 
-        t0 = ((Double_t)i*360./((Double_t)NssdSupports));
-        rot = new TGeoRotation("",0.0,0.0,t0);
-        Kv->AddNode(Tv,NcT++,rot);
-        Iv->AddNode(Uv,NcU++,rot);
-        for(j=0;j<2;j++)if(j!=0){ // 2 pin per bracket
-            t = t0 + ((Double_t)j)*0.5*DssdsddBracketAngle;
-            tran = new TGeoTranslation("",RinHole*TMath::Cos(t),
-                                       RinHole*TMath::Sin(t),
-                                       T->GetZ(T->GetNz()-1)-E->GetDz());
-            Kv->AddNode(Ev,NcE++,tran);
-        } // end for j
-    } // end for i
-    if(GetDebug()){
-        Av->PrintNodes();
-        Bv->PrintNodes();
-        Cv->PrintNodes();
-        Dv->PrintNodes();
-        Ev->PrintNodes();
-        Fv->PrintNodes();
-        Gv->PrintNodes();
-        Hv->PrintNodes();
-        Iv->PrintNodes();
-        Jv->PrintNodes();
-        Kv->PrintNodes();
-        Lv->PrintNodes();
-        Mv->PrintNodes();
-        Nv->PrintNodes();
-        Ov->PrintNodes();
-        Pv->PrintNodes();
-        Qv->PrintNodes();
-        Rv->PrintNodes();
-        Sv->PrintNodes();
-        Tv->PrintNodes();
-        Uv->PrintNodes();
-    } // end if
+
+    UpdateInternalGeometry();
+    AliITS::Init();
+
+    fIDMother = TVirtualMC::GetMC()->VolId("ITSV"); // ITS Mother Volume ID.
 }
+
 //______________________________________________________________________
-void AliITSv11::CreateMaterials(){
-    // Create ITS materials
-    //     This function defines the default materials used in the Geant
-    // Monte Carlo simulations for the geometries AliITSv11.
-    // In general it is automatically replaced by
+void AliITSv11::SetDefaults()
+{
+    // sets the default segmentation, response, digit and raw cluster classes
     // Inputs:
     //   none.
     // Outputs:
     //   none.
-    // Return
+    // Return:
     //   none.
 
-    //TGeoMaterial *C  = new TGeoMaterial("ITSCarbon",12.0,6.0,2.265);
-    TGeoMaterial *Al = new TGeoMaterial("ITSAluminum",26.981539,13.0,2.07);
-    TGeoMixture *Cfiber = new TGeoMixture("ITSCarbonFiber",6,1.930);
-    TGeoMixture *Rohacell = new TGeoMixture("ITSRohacell",6,1.930);
-    TGeoMixture *Staselite = new TGeoMixture("ITSStaselite4411w",6,1.930);
-    TGeoMixture *Air = new TGeoMixture("ITSAir",6,1.205*1.E-3);
-    TGeoMixture *Stainless = new TGeoMixture("ITSStainless",6,1.930);
-    //
-    Double_t SPDcone[20];
-    SPDcone[0] = 1.0; // imat
-    SPDcone[1] = 0.0; // isvol
-    SPDcone[2] = gAlice->Field()->Integ(); // ifield
-    SPDcone[3] = gAlice->Field()->Max(); // fieldm
-    SPDcone[4] = 1.0; // tmaxfd [degrees]
-    SPDcone[5] = 1.0; // stemax [cm]
-    SPDcone[6] = 0.5; // deemax [fraction]
-    SPDcone[7] = 1.0E-3; // epsil [cm]
-    SPDcone[8] = 0.0; // stmin [cm]
-    new TGeoMedium("ITSspdCarbonFiber",1,Cfiber,SPDcone);
-    SPDcone[0] += 1.0;
-    new TGeoMedium("ITSspdStaselite4411w",2,Staselite,SPDcone);
-    SPDcone[0] += 1.0;
-    new TGeoMedium("ITSspdRohacell50A",3,Rohacell,SPDcone);
-    SPDcone[0] += 1.0;
-    new TGeoMedium("ITSspdStainlesSteal",4,Stainless,SPDcone);
-    SPDcone[0] += 1.0;
-    new TGeoMedium("ITSspdAir",5,Air,SPDcone);
-    SPDcone[0] += 1.0;
-    new TGeoMedium("ITSspdAl",6,Al,SPDcone);
-    //
-    Double_t SSDcone[20];
-    SSDcone[0] = 1.0; // imat
-    SSDcone[1] = 0.0; // isvol
-    SSDcone[2] = gAlice->Field()->Integ(); // ifield
-    SSDcone[3] = gAlice->Field()->Max(); // fieldm
-    SSDcone[4] = 1.0; // tmaxfd [degrees]
-    SSDcone[5] = 1.0; // stemax [cm]
-    SSDcone[6] = 0.5; // deemax [fraction]
-    SSDcone[7] = 1.0E-3; // epsil [cm]
-    SSDcone[8] = 0.0; // stmin [cm]
-    new TGeoMedium("ITSssdCarbonFiber",1,Cfiber,SSDcone);
-    SSDcone[0] += 1.0;
-    new TGeoMedium("ITSssdStaselite4411w",2,Staselite,SSDcone);
-    SSDcone[0] += 1.0;
-    new TGeoMedium("ITSssdRohacell50A",3,Rohacell,SSDcone);
-    SSDcone[0] += 1.0;
-    new TGeoMedium("ITSssdStainlesSteal",4,Stainless,SSDcone);
-    SSDcone[0] += 1.0;
-    new TGeoMedium("ITSssdAir",5,Air,SSDcone);
-    SSDcone[0] += 1.0;
-    new TGeoMedium("ITSssdAl",6,Al,SSDcone);
+    if(!fDetTypeSim){
+       Warning("SetDefaults","Error fDetTypeSim not defined");
+       return;
+    }
+
+    fDetTypeSim->SetDefaults();
+    
+
+    if(fgkNTYPES>3){
+       Warning("SetDefaults",
+               "Only the four basic detector types are initialised!");
+    }// end if
+    return;
 }
+
 //______________________________________________________________________
-void AliITSv11::ServicesCableSupport(TGeoVolume *Moth){
-    // Define the detail ITS cable support trays on both the RB24 and 
-    // RB26 sides..
+void AliITSv11::StepManager()
+{
+    //    Called for every step in the ITS, then calles the AliITShit class
+    // creator with the information to be recoreded about that hit.
+    //     The value of the macro ALIITSPRINTGEOM if set to 1 will allow the
+    // printing of information to a file which can be used to create a .det
+    // file read in by the routine CreateGeometry(). If set to 0 or any other
+    // value except 1, the default behavior, then no such file is created nor
+    // it the extra variables and the like used in the printing allocated.
     // Inputs:
     //   none.
     // Outputs:
-    //  none.
+    //   none.
     // Return:
-    //  none.
-    // Based on the Drawings SSup_201A.jpg unless otherwise stated, 
-    // Volumes A..., 
-    TGeoMedium *SUPcf    = 0; // SUP support cone Carbon Fiber materal number.
-    TGeoMedium *SUPfs    = 0; // SUP support cone inserto stesalite 4411w.
-    TGeoMedium *SUPfo    = 0; // SUP support cone foam, Rohacell 50A.
-    TGeoMedium *SUPss    = 0; // SUP support cone screw material,Stainless
-    TGeoMedium *SUPair   = 0; // SUP support cone Air
-    TGeoMedium *SUPal    = 0; // SUP support cone SDD mounting bracket Al
-    TGeoMedium *SUPwater = 0; // SUP support cone Water
-    TGeoManager *mgr = gGeoManager;
-    SUPcf    = mgr->GetMedium("ITSssdCarbonFiber");
-    SUPfs    = mgr->GetMedium("ITSssdStaselite4411w");
-    SUPfo    = mgr->GetMedium("ITSssdRohacell50A");
-    SUPss    = mgr->GetMedium("ITSssdStainlessSteal");
-    SUPair   = mgr->GetMedium("ITSssdAir");
-    SUPal    = mgr->GetMedium("ITSssdAl");
-    SUPwater = mgr->GetMedium("ITSssdWater");
-    //
-    Int_t i,j;
-    Double_t x,y,z,t,t0,dt,di,r;
-
-    // RB 24 side
-    const Double_t Z024         = 900*kmm;//SSup_203A.jpg
-    const Double_t ThssFrame24  = 5.0*kmm;
-    const Double_t RssFrame24   = 444.5*kmm-ThssFrame24; // SSup_204A.jpg
-    const Double_t WidthFrame24 = 10.0*kmm;
-    const Double_t HightFrame24 = 10.0*kmm;
-    const Double_t Phi0Frame24  = 15.2*kDegree; // SSup_602A.jpg
-    const Double_t Phi1Frame24  = (90.0-7.6)*kDegree; // SSup_802A.jpg
-    const Double_t ZssFrameSection24 = (415.0-10.0)*kmm;
-    const Int_t    NZsections24      = 4;
-    const Int_t    NPhiSections24    = 4;
-    const Int_t    NFramesPhi24      = 4;
-    TGeoTubeSeg *A24,*M24; // Cylinderial support structure
-    TGeoBBox    *B24; // Cylinderial support structure
-
-    M24 = new TGeoTubeSeg("ITS sup Cable tray support frame mother volume M24",
-                          RssFrame24,RssFrame24+ThssFrame24,
-                          0.5*(4.*ZssFrameSection24+5*WidthFrame24),
-                          Phi0Frame24,Phi1Frame24);
-    A24 = new TGeoTubeSeg("ITS sup Cable tray support frame radial section A24",
-                          RssFrame24,RssFrame24+ThssFrame24,0.5*WidthFrame24,
-                          Phi0Frame24,Phi1Frame24);
-    B24 = new TGeoBBox("ITS sup Cable tray support frame Z section B24",
-                       0.5*ThssFrame24,0.5*HightFrame24,0.5*ZssFrameSection24);
-    printTubeSeg(A24);
-    printTubeSeg(M24);
-    printBBox(B24);
-    TGeoVolume *A24v,*B24v,*M24v;
-    TGeoTranslation *tran;
-    TGeoRotation    *rot;
-    TGeoCombiTrans  *tranrot;
-    //
-    A24v = new TGeoVolume("ITSsupFrameA24",A24,SUPss);
-    A24v->SetVisibility(kTRUE);
-    A24v->SetLineColor(1); // black
-    A24v->SetLineWidth(1);
-    A24v->SetFillColor(A24v->GetLineColor());
-    A24v->SetFillStyle(4000); // 0% transparent
-    B24v = new TGeoVolume("ITSsupFrameB24",B24,SUPss);
-    B24v->SetVisibility(kTRUE);
-    B24v->SetLineColor(1); // black
-    B24v->SetLineWidth(1);
-    B24v->SetFillColor(B24v->GetLineColor());
-    B24v->SetFillStyle(4000); // 0% transparent
-    M24v = new TGeoVolume("ITSsupFrameM24",M24,SUPair);
-    M24v->SetVisibility(kTRUE);
-    M24v->SetLineColor(7); // light blue
-    M24v->SetLineWidth(1);
-    M24v->SetFillColor(M24v->GetLineColor());
-    M24v->SetFillStyle(4090); // 90% transparent
-    //
-    Int_t NcA24=1,NcB24=1;
-    t0 = Phi0Frame24;
-    dt = (Phi1Frame24-Phi0Frame24)/((Double_t)NPhiSections24);
-    for(i=0;i<=NZsections24;i++){
-        di = (Double_t) i;
-        z = -M24->GetDz()+A24->GetDz() + di*(ZssFrameSection24+WidthFrame24);
-        tran = new TGeoTranslation("",0.0,0.0,z);
-        M24v->AddNode(A24v,NcA24++,tran);
-        r = RssFrame24+B24->GetDX();
-        z = z + A24->GetDz()+B24->GetDZ();
-       if(i<NZsections24) for(j=0;j<=NPhiSections24;j++){
-            t = t0 + ((Double_t)j)*dt;
-            rot = new TGeoRotation("",0.0,0.0,t);
-            y = r*TMath::Sin(t*kRadian);
-            x = r*TMath::Cos(t*kRadian);
-            tranrot = new TGeoCombiTrans("",x,y,z,rot);
-            delete rot;// rot not explicity used in AddNode functions.
-            M24v->AddNode(B24v,NcB24++,tranrot);
-        } // end for j
-    } // end for i
-    tran = new TGeoTranslation("",0.0,0.0,Z024+M24->GetDz());
-    Moth->AddNode(M24v,1,tran);
-    for(i=1;i<NFramesPhi24;i++){
-        di = (Double_t) i;
-        rot = new TGeoRotation("",0.0,0.0,90.0*di);
-        tranrot = new TGeoCombiTrans("",0.0,0.0,Z024+M24->GetDz(),rot);
-        delete rot;// rot not explicity used in AddNode functions.
-        Moth->AddNode(M24v,i+1,tranrot);
-    } // end for i
-    if(GetDebug()){
-        A24v->PrintNodes();
-        B24v->PrintNodes();
-        M24v->PrintNodes();
-    } // end if
-    // Cable support tray 
-    // Material is Aluminum
-    const Double_t RS24in     = TMath::Max(RssFrame24,444.5*kmm);
-                                           // SSup_204A & SSup_206A
-    const Double_t RS24Airout = 459.5*kmm; // SSup_204A & SSup_206A
-    const Double_t RS24out    = 494.5*kmm; // SSup_206A & SSup_204A
-    const Double_t RS24PPout  = 550.0*kmm; // SSup_206A
-    const Double_t LS24PP     = 350.0*kmm; // SSup_202A
-    const Double_t LS24       = (2693.0-900.0)*kmm; //SSup_205A & SSup_207A
-    const Double_t ThS24wall  = 1.0*kmm; // SSup_209A & SSup_210A
-    const Double_t WbS24      = 42.0*kmm; // SSup_209A & SSup_210A
-    const Double_t WtS24      = 46.9*kmm; // SSup_209A & SSup_210A
-    const Double_t WcapS24    = 50.0*kmm; // SSup_209A & SSup_210A
-    const Double_t WdS24      = 41.0*kmm; // SSup_209A ? should be 41.46938776
-    const Double_t HS24       = 50.0*kmm; // SSup_209A & SSup_210A
-    const Double_t OutDcoolTub= 12.0*kmm; // SSup_209A
-    const Double_t InDcoolTub = 10.0*kmm; // SSup_209A
-    const Double_t BlkNozInDS24= 6.0*kmm; // SSup_209A
-    // The following are deduced or guessed at
-    const Double_t LtopLipS24 = 6.0*kmm; // Guessed at.
-    const Double_t LdLipS24   = 6.0*kmm; // Guessed at.
-    const Double_t HdS24      = OutDcoolTub; //
-    const Double_t BlkNozZS24 = 6.0*kmm; // Guessed at.
-    // Simplifided exterior shape. The side wall size is 2.5*thicker than
-    // it should be (due to simplification).
-    TGeoArb8 *C24 = new TGeoArb8("ITS Sup Cable Tray Element C24",0.5*LS24);
-    C24->SetVertex(0,-0.5*WcapS24,HS24+ThS24wall);
-    C24->SetVertex(1,+0.5*WcapS24,HS24+ThS24wall);
-    C24->SetVertex(2,+0.5*WbS24,0.0);
-    C24->SetVertex(3,-0.5*WbS24,0.0);
-    C24->SetVertex(4,-0.5*WcapS24,HS24+ThS24wall);
-    C24->SetVertex(5,+0.5*WcapS24,HS24+ThS24wall);
-    C24->SetVertex(6,+0.5*WbS24,0.0);
-    C24->SetVertex(7,-0.5*WbS24,0.0);
-    TGeoArb8 *D24 = new TGeoArb8("ITS Sup Cable Tray lower Element D24",
-                                 0.5*LS24);
-    // Because of question about the value of WdS24, compute what it
-    // should be assuming cooling tube fixes hight of volume.
-    x = OutDcoolTub*(0.5*WcapS24-0.5*WbS24-ThS24wall)/(HS24-ThS24wall);
-    D24->SetVertex(0,-x,OutDcoolTub+ThS24wall);
-    D24->SetVertex(1,+x,OutDcoolTub+ThS24wall);
-    D24->SetVertex(2,+0.5*WbS24-ThS24wall,ThS24wall);
-    D24->SetVertex(3,-0.5*WbS24+ThS24wall,ThS24wall);
-    D24->SetVertex(4,-x,OutDcoolTub+ThS24wall);
-    D24->SetVertex(5,+x,OutDcoolTub+ThS24wall);
-    D24->SetVertex(6,+0.5*WbS24-ThS24wall,ThS24wall);
-    D24->SetVertex(7,-0.5*WbS24+ThS24wall,ThS24wall);
-    TGeoTube *E24 = new TGeoTube("ITS Sup Cooling Tube E24",0.5*InDcoolTub,
-                                 0.5*OutDcoolTub,0.5*LS24-BlkNozZS24);
-    TGeoArb8 *F24 = new TGeoArb8("ITS Sup Cable Tray lower Element block F24",
-                                 0.5*BlkNozZS24);
-    for(i=0;i<8;i++) F24->SetVertex(i,D24->GetVertices()[i*2+0],
-                                      D24->GetVertices()[i*2+1]); //
-    TGeoTube *G24 = new TGeoTube("ITS Sup Cooling Tube hole in block G24",
-                                 0.0,0.5*BlkNozInDS24,0.5*BlkNozZS24);
-    TGeoArb8 *H24 = new TGeoArb8("ITS Sup Cable Tray upper Element H24",
-                                 0.5*(LS24- LS24PP));
-    H24->SetVertex(0,C24->GetVertices()[0*2+0]+2.*ThS24wall,
-                     C24->GetVertices()[0*2+1]-ThS24wall);
-    H24->SetVertex(1,C24->GetVertices()[1*2+0]-2.*ThS24wall,
-                     C24->GetVertices()[1*2+1]-ThS24wall);
-    H24->SetVertex(2,D24->GetVertices()[1*2+0]-ThS24wall,
-                     D24->GetVertices()[1*2+1]+ThS24wall);
-    H24->SetVertex(3,D24->GetVertices()[0*2+0]+ThS24wall,
-                     D24->GetVertices()[0*2+1]+ThS24wall);
-    for(i=4;i<8;i++) H24->SetVertex(i,H24->GetVertices()[(i-4)*2+0],
-                                      H24->GetVertices()[(i-4)*2+1]); //
-    printArb8(C24);
-    printArb8(D24);
-    printTube(E24);
-    printArb8(F24);
-    printTube(G24);
-    printArb8(H24);
-    TGeoVolume *C24v,*D24v,*E24v,*F24v,*Ga24v,*Gw24v,*Gf24v,*H24v;
+    //   none.
+
+    if(!(this->IsActive())) return;
+    if(!(TVirtualMC::GetMC()->TrackCharge())) return;
+
+    Int_t copy, lay = 0;
+    Int_t id = TVirtualMC::GetMC()->CurrentVolID(copy);
+
+    Bool_t notSens = kFALSE;
+    while ((lay<fIdN)  && (notSens = id != fIdSens[lay])) ++lay;
+    if (notSens) return;
+
+    if(TVirtualMC::GetMC()->IsTrackExiting()) {
+       AddTrackReference(gAlice->GetMCApp()->GetCurrentTrackNumber(), AliTrackReference::kITS);
+    } // if Outer ITS mother Volume
+
+    static TLorentzVector position, momentum; // Saves on calls to construtors
+    static AliITShit hit;// Saves on calls to constructors
+
+    TClonesArray &lhits = *(Hits());
+    Int_t   cpn0, cpn1, mod, status = 0;
     //
-    C24v = new TGeoVolume("ITSsupCableTrayC24",C24,SUPal);
-    C24v->SetVisibility(kTRUE);
-    C24v->SetLineColor(6); //
-    C24v->SetLineWidth(1);
-    C24v->SetFillColor(C24v->GetLineColor());
-    C24v->SetFillStyle(4000); // 0% transparent
-    D24v = new TGeoVolume("ITSsupCableTrayLowerD24",D24,SUPair);
-    D24v->SetVisibility(kTRUE);
-    D24v->SetLineColor(6); //
-    D24v->SetLineWidth(1);
-    D24v->SetFillColor(D24v->GetLineColor());
-    D24v->SetFillStyle(4000); // 0% transparent
-    E24v = new TGeoVolume("ITSsupCableTrayCoolTubeE24",E24,SUPss);
-    E24v->SetVisibility(kTRUE);
-    E24v->SetLineColor(6); //
-    E24v->SetLineWidth(1);
-    E24v->SetFillColor(E24v->GetLineColor());
-    E24v->SetFillStyle(4000); // 0% transparent
-    F24v = new TGeoVolume("ITSsupCableTrayBlockF24",F24,SUPal);
-    F24v->SetVisibility(kTRUE);
-    F24v->SetLineColor(6); //
-    F24v->SetLineWidth(1);
-    F24v->SetFillColor(F24v->GetLineColor());
-    F24v->SetFillStyle(4000); // 0% transparent
-    Gw24v = new TGeoVolume("ITSsupCableTrayCoolantWaterG24",G24,SUPwater);
-    Gw24v->SetVisibility(kTRUE);
-    Gw24v->SetLineColor(6); //
-    Gw24v->SetLineWidth(1);
-    Gw24v->SetFillColor(Gw24v->GetLineColor());
-    Gw24v->SetFillStyle(4000); // 0% transparent
-    Ga24v = new TGeoVolume("ITSsupCableTrayCoolantAirG24",G24,SUPair);
-    Ga24v->SetVisibility(kTRUE);
-    Ga24v->SetLineColor(6); //
-    Ga24v->SetLineWidth(1);
-    Ga24v->SetFillColor(Ga24v->GetLineColor());
-    Ga24v->SetFillStyle(4000); // 0% transparent
-    H24v = new TGeoVolume("ITSsupCableTrayUpperC24",H24,SUPair);
-    H24v->SetVisibility(kTRUE);
-    H24v->SetLineColor(6); //
-    H24v->SetLineWidth(1);
-    H24v->SetFillColor(H24v->GetLineColor());
-    H24v->SetFillStyle(4000); // 0% transparent
+    // Track status
+    if(TVirtualMC::GetMC()->IsTrackInside())      status +=  1;
+    if(TVirtualMC::GetMC()->IsTrackEntering())    status +=  2;
+    if(TVirtualMC::GetMC()->IsTrackExiting())     status +=  4;
+    if(TVirtualMC::GetMC()->IsTrackOut())         status +=  8;
+    if(TVirtualMC::GetMC()->IsTrackDisappeared()) status += 16;
+    if(TVirtualMC::GetMC()->IsTrackStop())        status += 32;
+    if(TVirtualMC::GetMC()->IsTrackAlive())       status += 64;
+
     //
-    tran = new TGeoTranslation("",-OutDcoolTub,OutDcoolTub+ThS24wall,0.0);
-    F24v->AddNode(Gw24v,1,tran);
-    D24v->AddNode(E24v,1,tran);
-    tran = new TGeoTranslation("",0.0,OutDcoolTub+ThS24wall,0.0);
-    F24v->AddNode(Gw24v,2,tran);
-    D24v->AddNode(E24v,2,tran);
-    tran = new TGeoTranslation("",+OutDcoolTub,OutDcoolTub+ThS24wall,0.0);
-    F24v->AddNode(Gw24v,3,tran);
-    D24v->AddNode(E24v,3,tran);
-    tran = new TGeoTranslation("",0.0,0.0,0.5*LS24-0.5*BlkNozZS24);
-    D24v->AddNode(F24v,1,tran);
-    tran = new TGeoTranslation("",0.0,0.0,-(0.5*LS24-0.5*BlkNozZS24));
-    D24v->AddNode(F24v,2,tran);
-    C24v->AddNode(D24v,1,0);
-    C24v->AddNode(H24v,1,0);
-    //==================================================================
+    // retrieve the indices with the volume path
     //
-    // RB 26 side
-    const Double_t Z026         = -900*kmm;//SSup_203A.jpg
-    const Double_t ThssFrame26  = 5.0*kmm;
-    const Double_t R0ssFrame26  = 444.5*kmm-ThssFrame26; // SSup_204A.jpg
-    const Double_t R1ssFrame26  = 601.6*kmm-ThssFrame26; // SSup_208A.jpg
-    const Double_t WidthFrame26 = 10.0*kmm;
-    //const Double_t HightFrame26 = 10.0*kmm;
-    const Double_t Phi0Frame26  = 15.2*kDegree; // SSup_602A.jpg
-    const Double_t Phi1Frame26  = (90.0-7.6)*kDegree; // SSup_802A.jpg
-    const Double_t ZssFrameSection26 = (415.0-10.0)*kmm;
-    const Int_t    NZsections26      = 4;
-    const Int_t    NPhiSections26    = 4;
-    const Int_t    NFramesPhi26      = 4;
-    TGeoConeSeg *A26[NZsections26+1],*M26; // Cylinderial support structure
-    TGeoArb8     *B26; // Cylinderial support structure
-    Char_t name[100];
-    Double_t r1,r2,m;
-
-    M26 = new TGeoConeSeg("ITS sup Cable tray support frame mother volume M26",
-                         0.5*(4.*ZssFrameSection26+5*WidthFrame26),
-                          R1ssFrame26,R1ssFrame26+ThssFrame26,
-                          R0ssFrame26,R0ssFrame26+ThssFrame26,
-                          Phi0Frame26,Phi1Frame26);
-    m = -((R1ssFrame26-R0ssFrame26)/
-         (((Double_t)NZsections26)*(ZssFrameSection26+WidthFrame26)));
-    for(i=0;i<NZsections26+1;i++){
-        di = ((Double_t) i)*(ZssFrameSection26+WidthFrame26);
-        sprintf(name,
-                "ITS sup Cable tray support frame radial section A26[%d]",i);
-        r1 = R1ssFrame26+m*di;
-        r2 = R1ssFrame26+m*(di+WidthFrame26);
-        A26[i] = new TGeoConeSeg(name,0.5*WidthFrame26,r2,r2+ThssFrame26,
-                                 r1,r1+ThssFrame26,Phi0Frame26,Phi1Frame26);
-    } // end for i
-    B26 = new TGeoArb8("ITS sup Cable tray support frame Z section B26",
-                       0.5*ZssFrameSection26);
-    r = 0.25*(A26[0]->GetRmax1()+A26[0]->GetRmin1()+
-              A26[1]->GetRmax2()+A26[1]->GetRmin2());
-    B26->SetVertex(0,A26[0]->GetRmax2()-r,+0.5*WidthFrame26);
-    B26->SetVertex(1,A26[0]->GetRmax2()-r,-0.5*WidthFrame26);
-    B26->SetVertex(2,A26[0]->GetRmin2()-r,-0.5*WidthFrame26);
-    B26->SetVertex(3,A26[0]->GetRmin2()-r,+0.5*WidthFrame26);
-    B26->SetVertex(4,A26[1]->GetRmax1()-r,+0.5*WidthFrame26);
-    B26->SetVertex(5,A26[1]->GetRmax1()-r,-0.5*WidthFrame26);
-    B26->SetVertex(6,A26[1]->GetRmin1()-r,-0.5*WidthFrame26);
-    B26->SetVertex(7,A26[1]->GetRmin1()-r,+0.5*WidthFrame26);
-    for(i=0;i<NZsections26+1;i++) printConeSeg(A26[i]);
-    printConeSeg(M26);
-    printArb8(B26);
-    TGeoVolume *A26v[NZsections26+1],*B26v,*M26v;
+    switch (lay) {
+    case 0:case 1: // SPD
+      TVirtualMC::GetMC()->CurrentVolOffID(1,copy); // ladder
+      TVirtualMC::GetMC()->CurrentVolOffID(3,cpn1); // stave
+      TVirtualMC::GetMC()->CurrentVolOffID(5,cpn0); // sector
+      break;
+    case 2:case 3: // SDD
+      copy = 1;
+      TVirtualMC::GetMC()->CurrentVolOffID(2,cpn1);
+      TVirtualMC::GetMC()->CurrentVolOffID(3,cpn0);
+      break;
+    case 4:case 5: // SSD
+      copy = 1;
+      TVirtualMC::GetMC()->CurrentVolOffID(1,cpn1);
+      TVirtualMC::GetMC()->CurrentVolOffID(2,cpn0);
+      break;
+    default:
+      AliError(Form("Invalid value: lay= %d . Not an ITS sensitive volume",lay));
+      return; // not an ITS sensitive volume.
+    } //
+
+    fInitGeom.DecodeDetector(mod,lay+1,cpn0,cpn1,copy);
+    // We should not need to pass by the switch !
+    // This is time consuming...
+    // therefore DecodeDetectorv11(...) shouldn't be private !
+    // and we should be able to use instead :
+    //fInitGeom.DecodeDetectorv11(mod,lay+1,cpn0,cpn1,copy);
+
     //
-    for(i=0;i<NZsections26+1;i++){
-        sprintf(name,"ITSsupFrameA26[%d]",i);
-        A26v[i] = new TGeoVolume(name,A26[i],SUPss);
-        A26v[i]->SetVisibility(kTRUE);
-        A26v[i]->SetLineColor(1); // black
-        A26v[i]->SetLineWidth(1);
-        A26v[i]->SetFillColor(A26v[i]->GetLineColor());
-        A26v[i]->SetFillStyle(4000); // 0% transparent
-    } // end for i
-    B26v = new TGeoVolume("ITSsupFrameB26",B26,SUPss);
-    B26v->SetVisibility(kTRUE);
-    B26v->SetLineColor(1); // black
-    B26v->SetLineWidth(1);
-    B26v->SetFillColor(B26v->GetLineColor());
-    B26v->SetFillStyle(4000); // 0% transparent
-    M26v = new TGeoVolume("ITSsupFrameM26",M26,SUPair);
-    M26v->SetVisibility(kTRUE);
-    M26v->SetLineColor(7); // light blue
-    M26v->SetLineWidth(1);
-    M26v->SetFillColor(M26v->GetLineColor());
-    M26v->SetFillStyle(4090); // 90% transparent
+    // Fill hit structure.
     //
-    Int_t NcB26=1;
-    t0 = Phi0Frame26;
-    dt = (Phi1Frame26-Phi0Frame26)/((Double_t)NPhiSections26);
-    for(i=0;i<=NZsections26;i++){
-        di = ((Double_t) i)*(ZssFrameSection26+WidthFrame26);
-        z = -M26->GetDz()+A26[i]->GetDz() + di;
-        tran = new TGeoTranslation("",0.0,0.0,z);
-        M26v->AddNode(A26v[i],1,tran);
-        z = z+B26->GetDz();
-        if(i<NZsections26)for(j=0;j<=NPhiSections26;j++){
-            r = 0.25*(A26[i]->GetRmax1()+A26[i]->GetRmin1()+
-                      A26[i+1]->GetRmax2()+A26[i+1]->GetRmin2());
-            t = t0 + ((Double_t)j)*dt;
-            rot = new TGeoRotation("",0.0,0.0,t);
-            y = r*TMath::Sin(t*kRadian);
-            x = r*TMath::Cos(t*kRadian);
-            tranrot = new TGeoCombiTrans("",x,y,z,rot);
-            delete rot; // rot not explicity used in AddNode functions.
-            M26v->AddNode(B26v,NcB26++,tranrot);
-        } // end for j
-    } // end for i
-    tran = new TGeoTranslation("",0.0,0.0,Z026-M26->GetDz());
-    Moth->AddNode(M26v,1,tran);
-    for(i=1;i<NFramesPhi26;i++){
-        rot = new TGeoRotation("",0.0,0.0,90.0*((Double_t)i));
-        tranrot = new TGeoCombiTrans(*tran,*rot);
-        delete rot; // rot not explicity used in AddNode functions.
-        Moth->AddNode(M26v,i+1,tranrot);
-    } // end for i
-    if(GetDebug()){
-        for(i=0;i<NZsections26+1;i++) A26v[i]->PrintNodes();
-        B26v->PrintNodes();
-        M26v->PrintNodes();
-    } // end if
-}
-//______________________________________________________________________
-void AliITSv11::InitAliITSgeom(){
-    // Based on the geometry tree defined in Geant 3.21, this
-    // routine initilizes the Class AliITSgeom from the Geant 3.21 ITS 
-    // geometry sturture.
-    // Inputs:
-    //   none.
-    // Outputs:
-    //   none.
-    // Return
-    //   none.
-}
-//______________________________________________________________________
-void AliITSv11::Init(){
-    // Initialise the ITS after it has been created.
-    // Inputs:
-    //   none.
-    // Outputs:
-    //   none.
-    // Return
-    //   none.
-}
-//______________________________________________________________________
-void AliITSv11::SetDefaults(){
-    // Sets the default segmentation, response, digit and raw cluster 
-    // classes to be used. These defaults can be overwritten in the
-    // macros that do these later steps. Defaults are give hear for the
-    // general user.
-    // Inputs:
-    //   none.
-    // Outputs:
-    //   none.
-    // Return
-    //   none.
-}
-//______________________________________________________________________
-void AliITSv11::DrawModule(){
-    // Draw a standard set of shaded view of the ITS version 11.
-    // Inputs:
-    //   none.
-    // Outputs:
-    //   none.
-    // Return
-    //   none.
-}
-//______________________________________________________________________
-void AliITSv11::StepManager(){
-    // Called for every step in the ITS, then calles the AliITShit class
-    // creator with the information to be recoreded about that hit.
-    //  The value of the macro ALIITSPRINTGEOM if set to 1 will allow the
-    // printing of information to a file which can be used to create a .det
-    // file read in by the routine CreateGeometry(). If set to 0 or any other
-    // value except 1, the default behavior, then no such file is created nor
-    // is the extra variables and the like used in the printing allocated.
+    hit.SetModule(mod);
+    hit.SetTrack(gAlice->GetMCApp()->GetCurrentTrackNumber());
+    TVirtualMC::GetMC()->TrackPosition(position);
+    TVirtualMC::GetMC()->TrackMomentum(momentum);
+    hit.SetPosition(position);
+    hit.SetTime(TVirtualMC::GetMC()->TrackTime());
+    hit.SetMomentum(momentum);
+    hit.SetStatus(status);
+    hit.SetEdep(TVirtualMC::GetMC()->Edep());
+    hit.SetShunt(GetIshunt());
+    if(TVirtualMC::GetMC()->IsTrackEntering()){
+        hit.SetStartPosition(position);
+        hit.SetStartTime(TVirtualMC::GetMC()->TrackTime());
+        hit.SetStartStatus(status);
+        return; // don't save entering hit.
+    } // end if IsEntering
+    // Fill hit structure with this new hit.
+    //Info("StepManager","Calling Copy Constructor");
+    new(lhits[fNhits++]) AliITShit(hit); // Use Copy Construtor.
+    // Save old position... for next hit.
+    hit.SetStartPosition(position);
+    hit.SetStartTime(TVirtualMC::GetMC()->TrackTime());
+    hit.SetStartStatus(status);
+
+    return;
 }