]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - ZDC/AliZDC.cxx
...also histos are now correctly booked
[u/mrichter/AliRoot.git] / ZDC / AliZDC.cxx
index 38a8f88d2f70a3f3f4bd10bb167b6775c85a230e..8d3b556021cd9c247d7ca527b898b558ab74fb01 100644 (file)
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
 
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
 
-/*
-$Log$
-*/
+/* $Id$ */
 
 ///////////////////////////////////////////////////////////////////////////////
 //                                                                           //
 
 ///////////////////////////////////////////////////////////////////////////////
 //                                                                           //
-//  Zero Degree Calorimeter                                                  //
-//  This class contains the basic functions for the Time Of Flight           //
-//  detector. Functions specific to one particular geometry are              //
-//  contained in the derived classes                                         //
-//                                                                           //
-//Begin_Html
-/*
-<img src="picts/AliZDCClass.gif">
-</pre>
-<br clear=left>
-<font size=+2 color=red>
-<p>The responsible person for this module is
-<a href="mailto:Eugenio.Scomparin@cern.ch">Eugenio Scomparin</a>.
-</font>
-<pre>
-*/
-//End_Html
-//                                                                           //
+//                     Zero Degree Calorimeter                              //
+//          This class contains the basic functions for the ZDCs;           //
+//            functions specific to one particular geometry are              //
+//                      contained in the derived classes                     //
 //                                                                           //
 ///////////////////////////////////////////////////////////////////////////////
 
 //                                                                           //
 ///////////////////////////////////////////////////////////////////////////////
 
-#include <TBRIK.h>
-#include <TNode.h>
+// --- ROOT system
+#include <TClonesArray.h>
+#include <TTree.h>
+#include <TFile.h>
+#include <TSystem.h>
+#include <TRandom.h>
+#include <TParticle.h>
 
 
-#include "AliZDC.h"
+// --- AliRoot header files
+#include "AliDetector.h"
+#include "AliRawDataHeaderSim.h"
+#include "AliRawReader.h"
+#include "AliLoader.h"
 #include "AliRun.h"
 #include "AliRun.h"
-#include "AliCallf77.h"
-#include "AliConst.h"
 #include "AliMC.h"
 #include "AliMC.h"
+#include "AliLog.h"
+#include "AliDAQ.h"
+#include "AliZDC.h"
+#include "AliZDCHit.h"
+#include "AliZDCSDigit.h"
+#include "AliZDCDigit.h"
+#include "AliZDCDigitizer.h"
+#include "AliZDCRawStream.h"
+#include "AliZDCPedestals.h"
+#include "AliZDCEnCalib.h"
+#include "AliZDCTowerCalib.h"
+#include "AliFstream.h"
 
 
-#ifndef WIN32
-# define zdc_init       zdc_init_
-# define zdc_step       zdc_step_
-# define zdc_setbeam    zdc_setbeam_
-# define zdc_sethijing  zdc_sethijing_
-# define zdc_setvenus   zdc_setvenus_
-# define zdc_setkine    zdc_setkine_
-#else
-# define zdc_step       ZDC_STEP
-# define zdc_setbeam    ZDC_SETBEAM
-# define zdc_sethijing  ZDC_SETHIJING
-# define zdc_setvenus   ZDC_SETVENUS
-# define zdc_setkine    ZDC_SETKINE
-#endif
-
-extern "C" void type_of_call zdc_init();
-extern "C" void type_of_call zdc_step();
-extern "C" void type_of_call zdc_setbeam(Int_t beam, Float_t fx, Float_t fy,
-                                        Float_t sx, Float_t sy, Float_t div,
-                                        Float_t angle, Int_t cross);
-extern "C" void type_of_call zdc_sethijing(Int_t hij, Int_t hijf, Int_t hijsp,
-                                          DEFCHARD DEFCHARL);
-extern "C" void type_of_call zdc_setvenus(Int_t hiv, Int_t hivf, Int_t hivsp,
-                                         DEFCHARD DEFCHARL);
-extern "C" void type_of_call zdc_setkine(Int_t code, Float_t pmom, Float_t cx,
-                                        Float_t cy, Float_t cz, Int_t type,
-                                        Int_t fermi);
  
 ClassImp(AliZDC)
  
 ClassImp(AliZDC)
+
 //_____________________________________________________________________________
 //_____________________________________________________________________________
-AliZDC::AliZDC()
+AliZDC::AliZDC() :
+  AliDetector(),
+  fNoShower(0),
+  fPedCalib(0),
+  fEnCalibData(0),
+  fTowCalibData(0),
+  fZDCCalibFName(""),
+  fSpectatorTracked(1)
 {
   //
   // Default constructor for the Zero Degree Calorimeter base class
   //
 {
   //
   // Default constructor for the Zero Degree Calorimeter base class
   //
-  fIshunt   = 0;
+  
+  fIshunt = 1;
+  fNhits  = 0;
+  fHits = 0;
+  fDigits = 0;
+  fNdigits = 0;
+  
 }
  
 //_____________________________________________________________________________
 }
  
 //_____________________________________________________________________________
-AliZDC::AliZDC(const char *name, const char *title)
-  : AliDetector(name,title)
+AliZDC::AliZDC(const char *name, const char *title) : 
+  AliDetector(name,title),
+  fNoShower  (0),
+  fPedCalib(0),
+  fEnCalibData(0),
+  fTowCalibData(0),
+  fZDCCalibFName(""),
+  fSpectatorTracked(1)
 {
   //
   // Standard constructor for the Zero Degree Calorimeter base class
   //
 {
   //
   // Standard constructor for the Zero Degree Calorimeter base class
   //
-
-  //
-  // Allocate the array of hits
-  fHits   = new TClonesArray("AliZDChit",  405);
+    
+  fIshunt = 1;
+  fNhits  = 0;
+  fDigits = 0;
+  fNdigits = 0;
+  fHits = new TClonesArray("AliZDCHit",1000);
+  gAlice->GetMCApp()->AddHitList(fHits);
   
   
-  fIshunt     =  1;
+  SetName("ZDC"); SetTitle("ZDC");
+
 }
 }
-//_____________________________________________________________________________
-void AliZDC::AddHit(Int_t track, Int_t *vol, Float_t *hits)
+
+//____________________________________________________________________________ 
+AliZDC::~AliZDC()
 {
   //
 {
   //
-  // Add a Zero Degree Calorimeter hit
+  // ZDC destructor
   //
   //
-  TClonesArray &lhits = *fHits;
-  new(lhits[fNhits++]) AliZDChit(fIshunt,track,vol,hits);
+
+  fIshunt = 0;
+  if(fPedCalib) delete fPedCalib;
+  if(fEnCalibData) delete fEnCalibData;
+  if(fEnCalibData) delete fEnCalibData;
+
 }
 }
+
 //_____________________________________________________________________________
 //_____________________________________________________________________________
-void AliZDC::BuildGeometry()
+AliZDC::AliZDC(const AliZDC& ZDC) :
+AliDetector("ZDC","ZDC"),
+fNoShower(ZDC.fNoShower),
+fPedCalib(ZDC.fPedCalib),
+fEnCalibData(ZDC.fEnCalibData),
+fTowCalibData(ZDC.fTowCalibData),
+fZDCCalibFName(ZDC.fZDCCalibFName),
+fSpectatorTracked(ZDC.fSpectatorTracked)
 {
 {
-  //
-  // Build the ROOT TNode geometry for event display 
-  // in the Zero Degree Calorimeter
-  // This routine is dummy for the moment
-  //
-
-  //  TNode *Node, *Top;
-  //  TBRIK *brik;
-  //  const int kColorZDC  = kRed;
-  
-  //
-  // Top=gAlice->GetGeometry()->GetNode("alice");
-  
-  // ZDC
-  /*
-    brik = new TBRIK("S_ZDC","ZDC box","void",300,300,5);
-    Top->cd();
-    Node = new TNode("ZDC","ZDC","S_ZDC",0,0,600,"");
-    Node->SetLineColor(kColorZDC);
-    fNodes->Add(Node);
-  */
+  // copy constructor
 }
 
 //_____________________________________________________________________________
 }
 
 //_____________________________________________________________________________
-Int_t AliZDC::DistancetoPrimitive(Int_t , Int_t )
+AliZDC& AliZDC::operator=(const AliZDC& ZDC)
 {
 {
-  //
-  // Distance from the mouse to the Zero Degree Calorimeter
-  // Dummy routine
-  //
-  return 9999;
+  // assignement operator
+  if(this!=&ZDC){
+    fNoShower = ZDC.fNoShower;
+    fPedCalib = ZDC.fPedCalib;
+    fEnCalibData = ZDC.fEnCalibData;
+    fTowCalibData = ZDC.fTowCalibData;
+    fZDCCalibFName = ZDC.fZDCCalibFName;
+  } return *this;
 }
 }
+
 //_____________________________________________________________________________
 //_____________________________________________________________________________
-void AliZDC::SetBeam(Int_t beam, Float_t fx, Float_t fy, Float_t sx,
-                    Float_t sy, Float_t div, Float_t angle, Int_t cross)
+void AliZDC::AddHit(Int_t track, Int_t *vol, Float_t *hits)
 {
   //
 {
   //
-  // Set beam characteristic
-  // This routine has to be revised as it is disconnected from the
-  // actual generation in this version of AliRoot
-  //
+  //           Add a ZDC hit to the hit list.
+  
+  static Float_t trackTime=0., primKinEn=0., xImpact=0., yImpact=0., sFlag=0.;
+  static Int_t   pcPDGcode, motPDGcode;
+
+  AliZDCHit *newquad, *curprimquad;
+  newquad = new AliZDCHit(fIshunt, track, vol, hits);
+  TClonesArray &lhits = *fHits;
+  
+  if(fNhits==0){
+      // First hit -> setting flag for primary or secondary particle
+      TParticle * p = gAlice->GetMCApp()->Particle(track);
+      Int_t imo = p->GetFirstMother();
+      //
+      if(track != imo){
+        newquad->SetSFlag(1);  // SECONDARY particle entering the ZDC
+      }
+      else if(track == imo){
+        newquad->SetSFlag(0);  // PRIMARY particle entering the ZDC
+      }
+      //  
+      sFlag     = newquad->GetSFlag();
+      primKinEn  = newquad->GetPrimKinEn();
+      xImpact   = newquad->GetXImpact();
+      yImpact   = newquad->GetYImpact();
+      pcPDGcode         = newquad->GetPDGCode();
+      motPDGcode = newquad->GetMotherPDGCode();
+      trackTime  = newquad->GetTrackTOF();
+   }
+   else{       
+      newquad->SetPrimKinEn(primKinEn);
+      newquad->SetXImpact(xImpact);
+      newquad->SetYImpact(yImpact);
+      newquad->SetSFlag(sFlag);
+      newquad->SetPDGCode(pcPDGcode);
+      newquad->SetMotherPDGCode(motPDGcode);
+      newquad->SetTrackTOF(trackTime);
+   }
+  Int_t j;
+  for(j=0; j<fNhits; j++){
+    // If hits are equal (same track, same volume), sum them.
+     curprimquad = (AliZDCHit*) lhits[j];
+     if(*curprimquad == *newquad){
+        *curprimquad = *curprimquad+*newquad;
+        // Ch. debug
+        //printf("\n\t Summing hits **************** \n", fNhits);
+        //curprimquad->Print("");
+       //
+       delete newquad;
+       return;
+     } 
+  }
 
 
-  // beam  : 1 = gaussian beam
-  //       : 2 = uniform beam
-  // fx    : x-coordinate of beam offset
-  // fy    : y-coordinate of beam offset
-  // sx    : sigma-x of the beam (gaussian or uniform)
-  // sy    : sigma-y of the beam (gaussian or uniform)
-  // div   : divergency of the beam (32*10**-6 rad for LHC)
-  // angle : beam crossing angle (100*10**-6 rad for LHC)
-  // cross : 1 = horizontal beam crossing
-  //       : 2 = vertical beam crossing
-  zdc_setbeam(beam,fx,fy,sx,sy,div,angle,cross);
+    //Otherwise create a new hit
+    new(lhits[fNhits]) AliZDCHit(*newquad);
+    fNhits++;
+    // Ch. debug
+    //printf("\n\t New ZDC hit added! fNhits = %d\n", fNhits);
+    //newquad->Print("");
+    
+    delete newquad;
 }
 
 }
 
-//_____________________________________________________________________________
-void AliZDC::SetHijing(Int_t hij, Int_t hijf, Int_t hijsp, const char *file)
+//____________________________________________________________________________
+Float_t AliZDC::ZMin(void) const
 {
 {
-  //
-  // Set the parameter for the HIJING generation
-  // This routine has to be revised as it is disconnected from the
-  // actual generation in this version of AliRoot
-  //
+  // Minimum dimension of the ZDC module in z
+  return -11600.;
+}
 
 
-  // HIJ  : 1 = read HIJING event file
-  //      : 2 =  "     "      "    "    + debug
-  // HIJF : event number of the first event to be read from file
-  // HIJSP: 0 = read all particles
-  //      : 1 = remove spectator nucleons
-  zdc_sethijing(hij,hijf,hijsp, PASSCHARD(file) PASSCHARL(file));
+//____________________________________________________________________________
+Float_t AliZDC::ZMax(void) const
+{
+  // Maximum dimension of the ZDC module in z
+  return 11750.;
 }
 }
+  
 
 //_____________________________________________________________________________
 
 //_____________________________________________________________________________
-void AliZDC::SetVenus(Int_t hiv, Int_t hivf, Int_t hivsp, const char *file)
+void AliZDC::MakeBranch(Option_t *opt)
 {
   //
 {
   //
-  // Set the parameter for the VENUS generation
-  // This routine has to be revised as it is disconnected from the
-  // actual generation in this version of AliRoot
+  // Create Tree branches for the ZDC
   //
 
   //
 
-  // HIV  : 1 = read VENUS event file
-  //      : 2 =  "     "      "    "    + debug
-  // HIVF : event number of the first event to be read from file
-  // HIVSP: 0 = read all particles
-  //      : 1 = remove spectator nucleons
-  zdc_setvenus(hiv,hivf,hivsp, PASSCHARD(file) PASSCHARL(file));
+  char branchname[10];
+  snprintf(branchname, 10, "%s", GetName());
+
+  const char *cH = strstr(opt,"H");
+  
+  if(cH && fLoader->TreeH()) {
+    if (fHits) {
+      fHits->Clear();
+      fNhits = 0;
+    }
+    else {
+      fHits   = new TClonesArray("AliZDCHit",1000); 
+      if (gAlice && gAlice->GetMCApp())
+       gAlice->GetMCApp()->AddHitList(fHits);
+    }
+  }
+  
+  AliDetector::MakeBranch(opt);
 }
 
 //_____________________________________________________________________________
 }
 
 //_____________________________________________________________________________
-void AliZDC::SetKine(Int_t code, Float_t pmom, Float_t cx, Float_t cy,
-                    Float_t cz, Int_t type, Int_t fermi)
+void AliZDC::Hits2SDigits()
 {
 {
-  //
-  // Set the parameter for the event generation
-  // This routine has to be revised as it is disconnected from the
-  // actual generation in this version of AliRoot
-  //
+  // Create summable digits from hits
+  
+  AliDebug(1,"\n       AliZDC::Hits2SDigits() ");
+  
+  fLoader->LoadHits("read");
+  fLoader->LoadSDigits("recreate");
+  AliRunLoader* runLoader = fLoader->GetRunLoader();
+  AliZDCSDigit sdigit;
+  AliZDCSDigit* psdigit = &sdigit;
+
+  // Event loop
+  for(Int_t iEvent = 0; iEvent < runLoader->GetNumberOfEvents(); iEvent++) {
+    Float_t pmZNC[5], pmZPC[5], pmZNA[5], pmZPA[5], pmZEM1=0., pmZEM2=0.;
+    for(Int_t i=0; i<5; i++) pmZNC[i] = pmZPC[i] =  pmZNA[i] = pmZPA[i] = 0;
+
+    runLoader->GetEvent(iEvent);
+    TTree* treeH = fLoader->TreeH();
+    Int_t ntracks = (Int_t) treeH->GetEntries();
+    ResetHits();
+
+    // Tracks loop
+    Int_t sector[2]; Float_t trackTime = 0.;
+    for(Int_t itrack = 0; itrack < ntracks; itrack++) {
+      treeH->GetEntry(itrack);
+      for(AliZDCHit* zdcHit = (AliZDCHit*)FirstHit(-1); zdcHit;
+          zdcHit = (AliZDCHit*)NextHit()) { 
+                     
+       sector[0] = zdcHit->GetVolume(0);
+       sector[1] = zdcHit->GetVolume(1);
+       if((sector[1] < 1) || (sector[1]>5)) {
+         Error("Hits2SDigits", "sector[0] = %d, sector[1] = %d", sector[0], sector[1]);
+         continue;
+       }
+       Float_t lightQ = zdcHit->GetLightPMQ();
+       Float_t lightC = zdcHit->GetLightPMC();
+       trackTime = zdcHit->GetTrackTOF();
+       // Signals from ZEM are delayed to arrive in time with ZDC signals
+       if(sector[0] == 3)  trackTime += 320;
+       // Ch. debug
+       //printf("\t det %d vol %d trackTOF %f lightQ %1.0f lightC %1.0f\n",
+       //      sector[0], sector[1], trackTime, lightQ, lightC);
+     
+       if(sector[0] == 1) { //ZNC 
+         pmZNC[0] += lightC;
+         pmZNC[sector[1]] += lightQ;
+       } 
+       else if(sector[0] == 2) { //ZPC 
+         pmZPC[0] += lightC;
+         pmZPC[sector[1]] += lightQ;
+       } 
+       else if(sector[0] == 3) { //ZEM 
+         if(sector[1] == 1) pmZEM1 += lightC;
+         else pmZEM2 += lightQ;
+       }
+       if(sector[0] == 4) { //ZNA 
+         pmZNA[0] += lightC;
+         pmZNA[sector[1]] += lightQ;
+       } 
+       else if(sector[0] == 5) { //ZPA 
+         pmZPA[0] += lightC;
+         pmZPA[sector[1]] += lightQ;
+       } 
+      }//Hits loop
+    }//Tracks loop
+
+    // create the output tree
+    fLoader->MakeTree("S");
+    TTree* treeS = fLoader->TreeS();
+    const Int_t kBufferSize = 4000;
+    treeS->Branch(GetName(), "AliZDCSDigit", &psdigit, kBufferSize);
+
+    // Create sdigits for ZNC
+    sector[0] = 1; // Detector = ZNC
+    for(Int_t j = 0; j < 5; j++) {
+      sector[1] = j; 
+      if(pmZNC[j]>0){
+        new(psdigit) AliZDCSDigit(sector, pmZNC[j], trackTime);
+        treeS->Fill();
+       // Ch. debug
+       //printf("\t SDigit created: det %d quad %d pmZNC[%d] %1.0f trackTOF %f\n",
+       //      sector[0], sector[1], j, pmZNC[j], trackTime);
+      }
+    }
+  
+    // Create sdigits for ZPC
+    sector[0] = 2; // Detector = ZPC
+    for(Int_t j = 0; j < 5; j++) {
+      sector[1] = j; // Towers PM ADCs
+      if(pmZPC[j]>0){
+        new(psdigit) AliZDCSDigit(sector, pmZPC[j], trackTime);
+        treeS->Fill();
+       // Ch. debug
+       //printf("\t SDigit created: det %d quad %d pmZPC[%d] %1.0f trackTOF %f\n",
+       //      sector[0], sector[1], j, pmZPC[j], trackTime);
+      }
+    }
 
 
-  // code     : GEANT code of the test particle
-  // pmom     : absolute value of particle momentum
-  // cx,cy,cz : director cosines of the track (if type)
-  // type     :  0 = take director cosines from cx,cy,cz
-  //          : <>0 = pseudorapidity of the test particle
-  // fermi    : 0 = no Fermi motion for the spectator nucleons
-  //          : 1 = Fermi motion for the spectator nucleons
-  zdc_setkine(code,pmom,cx,cy,cz,type,fermi);
+    // Create sdigits for ZEM
+    sector[0] = 3; 
+    sector[1] = 1; // Detector = ZEM1
+    if(pmZEM1>0){ 
+      new(psdigit) AliZDCSDigit(sector, pmZEM1, trackTime);
+      treeS->Fill();
+      // Ch. debug
+      //printf("\t SDigit created: det %d quad %d pmZEM1 %1.0f trackTOF %f\n",
+      //       sector[0], sector[1], pmZEM1, trackTime);
+    }
+    sector[1] = 2; // Detector = ZEM2
+    if(pmZEM2>0){
+      new(psdigit) AliZDCSDigit(sector, pmZEM2, trackTime);
+      treeS->Fill();
+      // Ch. debug
+      //printf("\t SDigit created: det %d quad %d pmZEM2 %1.0f trackTOF %f\n",
+      //       sector[0], sector[1], pmZEM2, trackTime);
+    }
+
+    // Create sdigits for ZNA
+    sector[0] = 4; // Detector = ZNA
+    for(Int_t j = 0; j < 5; j++) {
+      sector[1] = j; // Towers PM ADCs
+      if(pmZNA[j]>0){
+        new(psdigit) AliZDCSDigit(sector, pmZNA[j], trackTime);
+        treeS->Fill();
+       // Ch. debug
+       //printf("\t SDigit created: det %d quad %d pmZNA[%d] %1.0f trackTOF %f\n",
+       //      sector[0], sector[1], j, pmZNA[j], trackTime);
+      }
+    }
+  
+    // Create sdigits for ZPA
+    sector[0] = 5; // Detector = ZPA
+    sector[1] = 0; // Common PM ADC
+    for(Int_t j = 0; j < 5; j++) {
+      sector[1] = j; // Towers PM ADCs
+      if(pmZPA[j]>0){
+        new(psdigit) AliZDCSDigit(sector, pmZPA[j], trackTime);
+        treeS->Fill();
+       // Ch. debug
+       //printf("\t SDigit created: det %d quad %d pmZPA[%d] %1.0f trackTOF %f\n",
+       //      sector[0], sector[1], j, pmZPA[j], trackTime);
+      }
+    }
+
+    // write the output tree
+    fLoader->WriteSDigits("OVERWRITE");
+  }
+
+  fLoader->UnloadHits();
+  fLoader->UnloadSDigits();
 }
 }
+
 //_____________________________________________________________________________
 //_____________________________________________________________________________
-void AliZDC::StepManager()
+AliDigitizer* AliZDC::CreateDigitizer(AliRunDigitizer* manager) const
 {
 {
-  //
-  // Routine called at every step in the Zero Degree Calorimeter
-  // This is a simple interface to the FORTRAN routine
-  // A step manager should be written
-  //
-  zdc_step();
+  // Create the digitizer for ZDC
+  AliZDCDigitizer *zdcDigitizer = new AliZDCDigitizer(manager);
+  if(fSpectatorTracked==0) zdcDigitizer->SetSpectators2Track();
+  //printf("\n**************************ZDC digitizer created with Spectators2Track = %d\n\n", fSpectatorTracked);
+  return zdcDigitizer;
 }
 
 }
 
-ClassImp(AliZDCv1)
+//_____________________________________________________________________________
+void AliZDC::Digits2Raw()
+{
+  // Convert ZDC digits to raw data
 
 
-///////////////////////////////////////////////////////////////////////////////
-//                                                                           //
-//  Zero Degree Calorimeter version 1                                        //
-//                                                                           //
-//Begin_Html
-/*
-<img src="picts/AliZDCv1Class.gif">
-*/
-//End_Html
-//                                                                           //
-//                                                                           //
-///////////////////////////////////////////////////////////////////////////////
+  // Format: 24 int values -> ZN1(C+Q1-4), ZP1(C+Q1-4), ZEM1, ZEM2, ZN(C+Q1-4), ZP2(C+Q1-4), 2 Ref PMs
+  //        + 24 int values for the corresponding out of time channels
+  // For the CAEN module V965 we have an Header, the Data Words and an End Of Block
+  //   12 channels x 2 gain chains read from 1st ADC module
+  //   12 channels x 2 gain chains read from 2nd ADC module
+  //   12 channels x 2 gain chains read from 3rd ADC module (o.o.t.)
+  //   12 channels x 2 gain chains read from 4rth ADC module (o.o.t.)
+  //
+  const int knADCData1=12, knADCData2=12; 
+  const int knADCData3=12, knADCData4=12; 
+  //
+  UInt_t lADCHeader1; 
+  UInt_t lADCHeader2; 
+  UInt_t lADCHeader3; 
+  UInt_t lADCHeader4; 
+  //
+  UInt_t lADCData1[2*knADCData1];
+  UInt_t lADCData2[2*knADCData2];
+  UInt_t lADCData3[2*knADCData3];
+  UInt_t lADCData4[2*knADCData4];
+  //
+  UInt_t lADCEndBlock;
+
+  // load the digits
+  fLoader->LoadDigits("read");
+  AliZDCDigit digit;
+  AliZDCDigit* pdigit = &digit;
+  TTree* treeD = fLoader->TreeD();
+  if(!treeD) return;
+  treeD->SetBranchAddress("ZDC", &pdigit);
+  //printf("\t AliZDC::Digits2Raw -> TreeD has %d entries\n",(Int_t) treeD->GetEntries());
+
+  // Reading channel map
+  //printf("\n\t Reading ADC mapping from OCDB\n");
+  AliZDCChMap * chMap = GetChMap();
+  const int nCh = knADCData1+knADCData2+knADCData3+knADCData4;
+  Int_t  mapADC[nCh][4]; 
+  for(Int_t i=0; i<nCh; i++){
+    mapADC[i][0] = chMap->GetADCModule(i);
+    mapADC[i][1] = chMap->GetADCChannel(i);
+    mapADC[i][2] = chMap->GetDetector(i);
+    mapADC[i][3] = chMap->GetSector(i);
+    // Ch. debug
+    //printf("  mapADC[%d] = (%d %d %d %d)\n", i,
+    // mapADC[i][0],mapADC[i][1],mapADC[i][2],mapADC[i][3]);
+  }
+
+  // *** Fill data array
+  // ** ADC header
+  UInt_t lADCHeaderGEO1 = 0;
+  UInt_t lADCHeaderGEO2 = 1;
+  UInt_t lADCHeaderGEO3 = 2;
+  UInt_t lADCHeaderGEO4 = 3;
+  UInt_t lADCHeaderCRATE = 0;
+  UInt_t lADCHeaderCNT1 = knADCData1;
+  UInt_t lADCHeaderCNT2 = knADCData2;
+  UInt_t lADCHeaderCNT3 = knADCData3;
+  UInt_t lADCHeaderCNT4 = knADCData4;
+    
+  lADCHeader1 = lADCHeaderGEO1 << 27 | 0x1 << 25 | lADCHeaderCRATE << 16 |
+               lADCHeaderCNT1 << 8 ;
+  lADCHeader2 = lADCHeaderGEO2 << 27 | 0x1 << 25 | lADCHeaderCRATE << 16 |
+               lADCHeaderCNT2 << 8 ;
+  lADCHeader3 = lADCHeaderGEO3 << 27 | 0x1 << 25 | lADCHeaderCRATE << 16 |
+               lADCHeaderCNT3 << 8 ;
+  lADCHeader4 = lADCHeaderGEO4 << 27 | 0x1 << 25 | lADCHeaderCRATE << 16 |
+               lADCHeaderCNT4 << 8 ;
+      
+  // ** ADC data word
+  UInt_t lADCDataGEO = 0;
+  //
+  UInt_t lADCDataValue1[2*knADCData1];
+  UInt_t lADCDataValue2[2*knADCData2];
+  UInt_t lADCDataValue3[2*knADCData3];
+  UInt_t lADCDataValue4[2*knADCData4];
+  //
+  UInt_t lADCDataOvFlwHG = 0;
+  UInt_t lADCDataOvFlwLG = 0;
+  //
+  for(Int_t i=0; i<2*knADCData1 ; i++) lADCDataValue1[i] = 0;
+  for(Int_t i=0; i<2*knADCData2 ; i++) lADCDataValue2[i] = 0;
+  for(Int_t i=0; i<2*knADCData3 ; i++) lADCDataValue3[i] = 0;
+  for(Int_t i=0; i<2*knADCData4 ; i++) lADCDataValue4[i] = 0;
+  //
+  UInt_t lADCDataChannel = 0;
+  
+  Int_t indADC0=0, indADC1=0, indADC2=0, indADC3=0;
+  
+  // loop over digits
+  for(Int_t iDigit=0; iDigit<(Int_t) (treeD->GetEntries()); iDigit++){
+    treeD->GetEntry(iDigit);
+    if(!pdigit) continue;
+    //digit.Print("");
+   
+    // *** ADC data
+    // Scan of the map to assign the correct ADC module-channel
+    for(Int_t k=0; k<nCh; k++){
+      if(iDigit<knADCData1+knADCData2){ 
+       if(digit.GetSector(0)==mapADC[k][2] && digit.GetSector(1)==mapADC[k][3]){
+        lADCDataGEO = (UInt_t) mapADC[k][0];
+        lADCDataChannel = (UInt_t) mapADC[k][1];
+        break;
+       } 
+      }
+      else{
+       if(digit.GetSector(0)==mapADC[k][2] && digit.GetSector(1)==mapADC[k][3]){
+        lADCDataGEO = (UInt_t) mapADC[k][0];
+        lADCDataChannel = (UInt_t) mapADC[k][1];
+        if(k>knADCData1+knADCData2) break;
+       } 
+      }
+    }
+    // Ch. debug
+    //printf("iDigit %d det %d sec %d -> lADCDataGEO %d  lADCDataChannel %d\n",
+    // iDigit,digit.GetSector(0),digit.GetSector(1),lADCDataGEO,lADCDataChannel);
+     
+    if(lADCDataGEO==0){ 
+      if(indADC0>=knADCData1){
+        AliWarning(" Problem with digit index 4 ADC0\n");
+       return;
+      }
+      Int_t indLG = indADC0+knADCData1;
+      // High gain ADC ch.      
+      if(digit.GetADCValue(0) > 2047) lADCDataOvFlwHG = 1; 
+      lADCDataValue1[indADC0] = digit.GetADCValue(0);    
+      lADCData1[indADC0] = lADCDataGEO << 27 |  lADCDataChannel << 17 | 
+                   lADCDataOvFlwHG << 12 | (lADCDataValue1[indADC0] & 0xfff); 
+      // Low gain ADC ch.
+      if(digit.GetADCValue(1) > 2047) lADCDataOvFlwLG = 1; 
+      lADCDataValue1[indLG] = digit.GetADCValue(1); 
+      lADCData1[indLG] = lADCDataGEO << 27 |  lADCDataChannel << 17 | 0x1 << 16 |
+                   lADCDataOvFlwLG << 12 | (lADCDataValue1[indLG] & 0xfff);  
+      // Ch. debug
+      //printf(" lADCDataGEO %d  ADCdataHG[%d] %d  ADCdataLG[%d] %d\n", 
+      //  lADCDataGEO,indADC0,lADCDataValue1[indADC0],indLG,lADCDataValue1[indLG]);
+                   
+      indADC0++;
+    }
+    else if(lADCDataGEO==1){ 
+      if(indADC1>=knADCData2){
+         AliWarning(" Problem with digit index 4 ADC1\n");
+        return;
+      }
+      Int_t indLG = indADC1+knADCData2;
+      // High gain ADC ch.      
+      if(digit.GetADCValue(0) > 2047) lADCDataOvFlwHG = 1; 
+      lADCDataValue2[indADC1] = digit.GetADCValue(0);   
+      lADCData2[indADC1] = lADCDataGEO << 27 | lADCDataChannel << 17 | 
+                   lADCDataOvFlwHG << 12 | (lADCDataValue2[indADC1] & 0xfff); 
+      // Low gain ADC ch.
+      if(digit.GetADCValue(1) > 2047) lADCDataOvFlwLG = 1; 
+      lADCDataValue2[indLG] = digit.GetADCValue(1); 
+      lADCData2[indLG] = lADCDataGEO << 27 |  lADCDataChannel << 17 | 0x1 << 16 |
+                   lADCDataOvFlwLG << 12 | (lADCDataValue2[indLG] & 0xfff);  
+      // Ch. debug
+      //printf(" lADCDataGEO %d  ADCdataHG[%d] %d  ADCdataLG[%d] %d\n", 
+      //  lADCDataGEO,indADC1,lADCDataValue2[indADC1],indLG,lADCDataValue2[indLG]);
+                 
+      indADC1++;
+    }
+    else if(lADCDataGEO==2){ 
+      if(indADC2>=knADCData3){
+        AliWarning(" Problem with digit index 4 ADC2\n");
+       return;
+      }
+      Int_t indLG = indADC2+knADCData3;
+      // High gain ADC ch.      
+      if(digit.GetADCValue(0) > 2047) lADCDataOvFlwHG = 1; 
+      lADCDataValue3[indADC1] = digit.GetADCValue(0);    
+      lADCData3[indADC1] = lADCDataGEO << 27 | lADCDataChannel << 17 | 
+                   lADCDataOvFlwHG << 12 | (lADCDataValue3[indADC2] & 0xfff); 
+      // Low gain ADC ch.
+      if(digit.GetADCValue(1) > 2047) lADCDataOvFlwLG = 1; 
+      lADCDataValue3[indLG] = digit.GetADCValue(1); 
+      lADCData3[indLG] = lADCDataGEO << 27 |  lADCDataChannel << 17 | 0x1 << 16 |
+                   lADCDataOvFlwLG << 12 | (lADCDataValue3[indLG] & 0xfff);  
+      // Ch. debug
+      //printf(" lADCDataGEO %d  ADCdataHG[%d] %d  ADCdataLG[%d] %d\n", 
+      //  lADCDataGEO,indADC2,lADCDataValue3[indADC2],indLG,lADCDataValue3[indLG]);
+                 
+      indADC2++;
+    }
+    else if(lADCDataGEO==3){ 
+      if(indADC3>=knADCData4){
+         AliWarning(" Problem with digit index 4 ADC2\n");
+        return;
+      }
+      Int_t indLG = indADC3+knADCData4;
+      // High gain ADC ch.      
+      if(digit.GetADCValue(0) > 2047) lADCDataOvFlwHG = 1; 
+      lADCDataValue4[indADC3] = digit.GetADCValue(0);    
+      lADCData4[indADC3] = lADCDataGEO << 27 | lADCDataChannel << 17 | 
+                   lADCDataOvFlwHG << 12 | (lADCDataValue4[indADC3] & 0xfff); 
+      // Low gain ADC ch.
+      if(digit.GetADCValue(1) > 2047) lADCDataOvFlwLG = 1; 
+      lADCDataValue4[indLG] = digit.GetADCValue(1); 
+      lADCData4[indLG] = lADCDataGEO << 27 |  lADCDataChannel << 17 | 0x1 << 16 |
+                   lADCDataOvFlwLG << 12 | (lADCDataValue4[indLG] & 0xfff);  
+      // Ch. debug
+      //printf(" lADCDataGEO %d  ADCdataHG[%d] %d  ADCdataLG[%d] %d\n", 
+      //  lADCDataGEO,indADC3,lADCDataValue4[indADC3],indLG,lADCDataValue4[indLG]);
+                 
+      indADC3++;
+    }            
+
+  }
+  //
+  /*for(Int_t i=0;i<2*knADCData1;i++) printf("\t ADCData1[%d] = %x\n",i,lADCData1[i]);
+  for(Int_t i=0;i<2*knADCData2;i++) printf("\t ADCData2[%d] = %x\n",i,lADCData2[i]);
+  for(Int_t i=0;i<2*knADCData3;i++) printf("\t ADCData3[%d] = %x\n",i,lADCData3[i]);
+  for(Int_t i=0;i<2*knADCData4;i++) printf("\t ADCData4[%d] = %x\n",i,lADCData4[i]);*/
+   
+  // End of Block
+  UInt_t lADCEndBlockGEO = 0;
+  // Event counter in ADC EOB -> getting no. of events in run from AliRunLoader
+  // get run loader
+  AliRunLoader* runLoader = fLoader->GetRunLoader(); 
+  UInt_t lADCEndBlockEvCount = runLoader->GetEventNumber();
+  //  
+  lADCEndBlock = lADCEndBlockGEO << 27 | 0x1 << 26 | lADCEndBlockEvCount;
+  //printf("\t AliZDC::Digits2Raw -> ADCEndBlock = %d\n",lADCEndBlock);
+
+  // open the output file
+  TString fileName;
+  fileName.Form("%s",AliDAQ::DdlFileName("ZDC",0)); 
+
+  AliFstream* file = new AliFstream(fileName.Data());
+
+  // write the DDL data header
+  AliRawDataHeaderSim header;
+  header.fSize = sizeof(header) + 
+                 sizeof(lADCHeader1) + sizeof(lADCData1) + sizeof(lADCEndBlock) +
+                sizeof(lADCHeader2) + sizeof(lADCData2) + sizeof(lADCEndBlock) +
+                 sizeof(lADCHeader3) + sizeof(lADCData3) + sizeof(lADCEndBlock) +
+                sizeof(lADCHeader4) + sizeof(lADCData4) + sizeof(lADCEndBlock);
+  //
+  /*printf("sizeof header = %d, ADCHeader1 = %d, ADCData1 = %d, ADCEndBlock = %d\n",
+          sizeof(header),sizeof(lADCHeader1),sizeof(lADCData1),sizeof(lADCEndBlock));
+  printf("sizeof header = %d, ADCHeader2 = %d, ADCData2 = %d, ADCEndBlock = %d\n",
+          sizeof(header),sizeof(lADCHeader2),sizeof(lADCData2),sizeof(lADCEndBlock));
+  printf("sizeof header = %d, ADCHeader3 = %d, ADCData3 = %d, ADCEndBlock = %d\n",
+          sizeof(header),sizeof(lADCHeader1),sizeof(lADCData1),sizeof(lADCEndBlock));
+  printf("sizeof header = %d, ADCHeader4 = %d, ADCData4 = %d, ADCEndBlock = %d\n",
+          sizeof(header),sizeof(lADCHeader2),sizeof(lADCData2),sizeof(lADCEndBlock));*/
+  
+  header.SetAttribute(0);  // valid data
+  file->WriteBuffer((char*)(&header), sizeof(header));
+  // write the raw data and close the file
+  file->WriteBuffer((char*) &lADCHeader1,  sizeof (lADCHeader1));
+  file->WriteBuffer((char*) &lADCData1,   sizeof(lADCData1));
+  file->WriteBuffer((char*) &lADCEndBlock, sizeof(lADCEndBlock));
+  file->WriteBuffer((char*) &lADCHeader2,  sizeof (lADCHeader2));
+  file->WriteBuffer((char*) (lADCData2),   sizeof(lADCData2));
+  file->WriteBuffer((char*) &lADCEndBlock, sizeof(lADCEndBlock));
+  file->WriteBuffer((char*) &lADCHeader3,  sizeof (lADCHeader3));
+  file->WriteBuffer((char*) (lADCData3),   sizeof(lADCData3));
+  file->WriteBuffer((char*) &lADCEndBlock, sizeof(lADCEndBlock));
+  file->WriteBuffer((char*) &lADCHeader4,  sizeof (lADCHeader4));
+  file->WriteBuffer((char*) (lADCData4),   sizeof(lADCData4));
+  file->WriteBuffer((char*) &lADCEndBlock, sizeof(lADCEndBlock));
+  delete file;
+
+  // unload the digits
+  fLoader->UnloadDigits();
+}
 
 //_____________________________________________________________________________
 
 //_____________________________________________________________________________
-AliZDCv1::AliZDCv1() : AliZDC()
+Bool_t AliZDC::Raw2SDigits(AliRawReader* rawReader)
 {
 {
-  //
-  // Default constructor for Zero Degree Calorimeter
-  //
+  // Convert ZDC raw data to Sdigits
+  const int kNch = 48;
+  AliLoader* loader = (AliRunLoader::Instance())->GetLoader("ZDCLoader");
+  if(!loader) {
+    AliError("no ZDC loader found");
+    return kFALSE;
+  }
+
+  // Create the output digit tree
+  TTree* treeS = loader->TreeS();
+  if(!treeS){
+    loader->MakeTree("S");
+    treeS = loader->TreeS();
+  }
+  //
+  AliZDCSDigit sdigit;
+  AliZDCSDigit* psdigit = &sdigit;
+  const Int_t kBufferSize = 4000;
+  treeS->Branch("ZDC", "AliZDCSDigit",  &psdigit, kBufferSize);
+  //
+  AliZDCRawStream rawStream(rawReader);
+  Int_t sector[2], resADC, rawADC, corrADC, nPheVal;
+  Int_t jcount = 0;
+  while(rawStream.Next()){
+    if(rawStream.IsADCDataWord()){
+      //For the moment only in-time SDigits are foreseen (1st 48 raw values)
+      if(jcount < kNch){ 
+       for(Int_t j=0; j<2; j++) sector[j] = rawStream.GetSector(j);
+        rawADC = rawStream.GetADCValue();
+        resADC = rawStream.GetADCGain();
+        //printf("\t RAw2SDigits raw%d ->  RawADC[%d, %d, %d] read\n",
+        //    jcount, sector[0], sector[1], rawADC);
+        //
+        corrADC = rawADC - Pedestal(sector[0], sector[1], resADC);
+        if(corrADC<0) corrADC=0;
+        nPheVal = ADCch2Phe(sector[0], sector[1], corrADC, resADC);
+       //
+        //printf("\t \t ->  SDigit[%d, %d, %d] created\n",
+        //    sector[0], sector[1], nPheVal);
+        //
+       new(psdigit) AliZDCSDigit(sector, (Float_t) nPheVal, 0.);
+       treeS->Fill();
+       jcount++;
+      }
+    }//IsADCDataWord
+  }//rawStream.Next
+  // write the output tree
+  fLoader->WriteSDigits("OVERWRITE");
+  fLoader->UnloadSDigits();
+   
+  return kTRUE;
 }
 }
+
 //_____________________________________________________________________________
 //_____________________________________________________________________________
-AliZDCv1::AliZDCv1(const char *name, const char *title)
-  : AliZDC(name,title)
+Int_t AliZDC::Pedestal(Int_t Det, Int_t Quad, Int_t Res) const
 {
 {
+  // Returns a pedestal for detector det, PM quad, channel with res.
   //
   //
-  // Standard constructor for Zero Degree Calorimeter 
+  // Getting calibration object for ZDC set
+  AliCDBManager *man = AliCDBManager::Instance();
+  AliCDBEntry  *entry = man->Get("ZDC/Calib/Pedestals");
+  if(!entry) AliFatal("No calibration data loaded!");  
+  AliZDCPedestals *calibPed = (AliZDCPedestals*) entry->GetObject();
   //
   //
-}
-//_____________________________________________________________________________
-void AliZDCv1::CreateGeometry()
-{
+  if(!calibPed){
+    printf("\t No calibration object found for ZDC!");
+    return -1;
+  }
   //
   //
-  // Create the geometry for the Zero Degree Calorimeter version 1
-  // -- Author :    E Scomparin
+  Int_t index=0, kNch=24;
+  if(Quad!=5){
+    if(Det==1)        index = Quad+kNch*Res;    // ZN1
+    else if(Det==2)   index = Quad+5+kNch*Res;          // ZP1
+    else if(Det==3)   index = Quad+9+kNch*Res; // ZEM
+    else if(Det==4)   index = Quad+12+kNch*Res; // ZN2
+    else if(Det==5)   index = Quad+17+kNch*Res; // ZP2
+  }
+  else index = (Det-1)/3+22+kNch*Res; // Reference PMs
   //
   //
-  //Begin_Html
-  /*
-    <img src="picts/AliZDCv1.gif">
-  */
-  //End_Html
-  //Begin_Html
-  /*
-    <img src="picts/AliZDCv1Tree.gif">
-  */
-  //End_Html
-
-  // The following variables were illegaly initialized in zdc_init.
-  // These variables should become data members of this class
-  // once zdc_init has been converted
-  //* Initialize COMMON block ZDC_CGEOM
-  //*
-  
-  const Int_t NZPTX=4;
-  const Int_t NZPTY=1;
-  const Int_t NZNTX=2;
-  const Int_t NZNTY=2;
-  
-  Float_t HDZN[3]  = {4.0,4.0,50.0};
-  Float_t HDZP[3]  = {10.0,6.0,75.0};
-  // Coordinates of the center of the ZDC front face in the MRS
-  Float_t ZNPOS[3] = {-0.5,0.,11613.};
-  Float_t ZPPOS[3] = {-21.0,0.,11563.};
-  Float_t FIZN[3]  = {0.,0.01825,50.0};
-  Float_t FIZP[3]  = {0.,0.01825,75.0};
-  Float_t GRZN[3]  = {0.025,0.025,50.0};
-  Float_t GRZP[3]  = {0.040,0.040,75.0};
-  Int_t NCEN[3]    = {11,11,0};
-  Int_t NCEP[3]    = {10,10,0};
-  
-  Float_t angle;
-  Float_t zq, conpar[9], tubpar[3];
-  Int_t im1, im2;
-  Float_t zd1, zd2;
-  
-  
-  Int_t *idtmed = fIdtmed->GetArray()-799;
-  
-  // -- Mother of the ZDC 
-  conpar[0] = 0.;
-  conpar[1] = 360.;
-  conpar[2] = 2.;
-  conpar[3] = 1920.;
-  conpar[4] = 0.;
-  conpar[5] = 55.;
-  conpar[6] = 13060.;
-  conpar[7] = 0.;
-  conpar[8] = 55.;
-  gMC->Gsvolu("ZDC ", "PCON", idtmed[891], conpar, 9);
-  gMC->Gspos("ZDC ", 1, "ALIC", 0., 0., 0., 0, "ONLY");
-  // -- FIRST SECTION OF THE BEAM PIPE (from compensator dipole to 
-  //    beginning of D1) 
-  
-  zd1 = 1920.;
-  
-  tubpar[0] = 2.3;
-  tubpar[1] = 2.5;
-  tubpar[2] = 1961.75;
-  gMC->Gsvolu("P001", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P001", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  //-- SECOND SECTION OF THE BEAM PIPE (FROM THE END OF D1 TO THE BEGINNING OF
-  //    D2) 
-  
-  zd1 = 6316.+472.5;
-  
-  tubpar[0] = 7.3/2.;
-  tubpar[1] = 7.7/2.;
-  tubpar[2] = 90.*0.5;
-  gMC->Gsvolu("P002", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P002", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  tubpar[0] = 7.3/2.;
-  tubpar[1] = 7.7/2.;
-  tubpar[2] = 10.*0.5;
-  gMC->Gsvolu("P003", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P003", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  conpar[0] = 3.16/2.;
-  conpar[1] = 7.3/2.;
-  conpar[2] = 7.7/2.;
-  conpar[3] = 9.8/2.;
-  conpar[4] = 10.0/2.;
-  gMC->Gsvolu("P004", "CONE", idtmed[851], conpar, 5);
-  gMC->Gspos("P004", 1, "ZDC ", 0., 0., conpar[0] + zd1, 0, "ONLY");
-  
-  zd1 += conpar[0] * 2.;
-  
-  tubpar[0] = 9.8/2.;
-  tubpar[1] = 10.0/2;
-  tubpar[2] = 490./2.;
-  gMC->Gsvolu("P005", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P005", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  conpar[0] = 30./2.;
-  conpar[1] = 9.8/2.;
-  conpar[2] = 10.0/2.;
-  conpar[3] = 20.4/2.;
-  conpar[4] = 20.6/2.;
-  gMC->Gsvolu("P006", "CONE", idtmed[851], conpar, 5);
-  gMC->Gspos("P006", 1, "ZDC ", 0., 0., conpar[0] + zd1, 0, "ONLY");
-  
-  zd1 += conpar[0] * 2.;
-  
-  tubpar[0] = 20.4/2.;
-  tubpar[1] = 20.6/2.;
-  tubpar[2] = 150./2.;
-  gMC->Gsvolu("P007", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P007", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  conpar[0] = 13.6/2.;
-  conpar[1] = 20.4/2.;
-  conpar[2] = 20.6/2.;
-  conpar[3] = 25.2/2.;
-  conpar[4] = 25.4/2.;
-  gMC->Gsvolu("P008", "CONE", idtmed[851], conpar, 5);
-  gMC->Gspos("P008", 1, "ZDC ", 0., 0., conpar[0] + zd1, 0, "ONLY");
-  
-  zd1 += conpar[0] * 2.;
-  
-  tubpar[0] = 25.2/2.;
-  tubpar[1] = 25.4/2.;
-  tubpar[2] = 205.8/2.;
-  gMC->Gsvolu("P009", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P009", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  tubpar[0] = 43.8/2.;
-  tubpar[1] = 44.0/2.;
-  tubpar[2] = 500./2.;
-  gMC->Gsvolu("P010", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P010", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  tubpar[0] = 31.8/2.;
-  tubpar[1] = 32.0/2.;
-  tubpar[2] = 757.5/2.;
-  gMC->Gsvolu("P011", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P011", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  conpar[0] = 22.7/2.;
-  conpar[1] = 31.8/2.;
-  conpar[2] = 32.0/2.;
-  conpar[3] = 39.8/2.;
-  conpar[4] = 40.0/2.;
-  gMC->Gsvolu("P012", "CONE", idtmed[851], conpar, 5);
-  gMC->Gspos("P012", 1, "ZDC ", 0., 0., conpar[0] + zd1, 0, "ONLY");
-  
-  zd1 += conpar[0] * 2.;
-  
-  tubpar[0] = 39.8/2.;
-  tubpar[1] = 40.0/2.;
-  tubpar[2] = 100./2.;
-  gMC->Gsvolu("P013", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P013", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  tubpar[0] = 39.8/2.;
-  tubpar[1] = 40.0/2.;
-  tubpar[2] = 600./2.;
-  gMC->Gsvolu("P014", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P014", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  conpar[0] = 28.4/2.;
-  conpar[1] = 39.8/2.;
-  conpar[2] = 40.0/2.;
-  conpar[3] = 49.8/2.;
-  conpar[4] = 50.0/2.;
-  gMC->Gsvolu("P015", "CONE", idtmed[851], conpar, 5);
-  gMC->Gspos("P015", 1, "ZDC ", 0., 0., conpar[0] + zd1, 0, "ONLY");
-  
-  zd1 += conpar[0] * 2.;
-  
-  tubpar[0] = 49.8/2.;
-  tubpar[1] = 50.0/2.;
-  tubpar[2] = 100./2.;
-  gMC->Gsvolu("P016", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P016", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  tubpar[0] = 49.8/2.;
-  tubpar[1] = 50.0/2.;
-  tubpar[2] = 600./2.;
-  gMC->Gsvolu("P017", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P017", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  conpar[0] = 28.4/2.;
-  conpar[1] = 49.8/2.;
-  conpar[2] = 50.0/2.;
-  conpar[3] = 59.8/2.;
-  conpar[4] = 60.0/2.;
-  gMC->Gsvolu("P018", "CONE", idtmed[851], conpar, 5);
-  gMC->Gspos("P018", 1, "ZDC ", 0., 0., conpar[0] + zd1, 0, "ONLY");
-  
-  zd1 += conpar[0] * 2.;
-  
-  tubpar[0] = 59.8/2.;
-  tubpar[1] = 60.0/2.;
-  tubpar[2] = 50./2.;
-  gMC->Gsvolu("P019", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P019", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  tubpar[0] = 59.8/2.;
-  tubpar[1] = 60.0/2.;
-  tubpar[2] = 800./2.;
-  gMC->Gsvolu("P020", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P020", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 60.0/2.;
-  tubpar[2] = 0.2/2.;
-  gMC->Gsvolu("P021", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("P021", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  
-  zd1 += tubpar[2] * 2.;
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 4.4/2.;
-  tubpar[2] = 0.2/2.;
-  gMC->Gsvolu("Q021", "TUBE", idtmed[889], tubpar, 3);
-  tubpar[0] = 0.;
-  tubpar[1] = 7.0/2.;
-  tubpar[2] = 0.2/2.;
-  gMC->Gsvolu("R021", "TUBE", idtmed[889], tubpar, 3);
-  // -- POSITION Q021 INSIDE P021 
-  gMC->Gspos("Q021", 1, "P021", -7.7, 0., 0., 0, "ONLY");
-  // -- POSITION R020 INSIDE P020 
-  gMC->Gspos("R021", 1, "P021", 7.7, 0., 0., 0, "ONLY");
-  
-  // -- BEAM PIPES BETWEEN END OF CONICAL PIPE AND BEGINNING OF D2 
-  tubpar[0] = 4.0/2.;
-  tubpar[1] = 4.4/2.;
-  tubpar[2] = 645.*0.5;
-  gMC->Gsvolu("P022", "TUBE", idtmed[851], tubpar, 3);
-  tubpar[0] = 7.0/2.;
-  tubpar[1] = 7.4/2.;
-  tubpar[2] = 645.*0.5;
-  gMC->Gsvolu("P023", "TUBE", idtmed[851], tubpar, 3);
-  
-  // -- ROTATE PIPES 
-  AliMatrix(im1, 90.-0.071, 0., 90., 90., .071, 180.);
-  angle = .071*kDegrad;
-  gMC->Gspos("P022", 1, "ZDC ", TMath::Sin(angle) * 322.5 - 9.7 + 
-              TMath::Sin(angle) * 472.5, 0., tubpar[2] + zd1, im1, "ONLY");
-  AliMatrix(im2, 90.+0.071, 0., 90., 90., .071, 0.);
-  gMC->Gspos("P023", 1, "ZDC ", 9.7 - TMath::Sin(angle) * 322.5, 0., 
-              tubpar[2] + zd1, im2, "ONLY");
-  
-  // --  END OF BEAM PIPE VOLUME DEFINITION. MAGNET DEFINITION FOLLOWS 
-  //     (LHC OPTICS 6) 
-  
-  // -- COMPENSATOR DIPOLE (MCBWA) 
-  //     GAP (VACUUM WITH MAGNETIC FIELD) 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 4.5;
-  tubpar[2] = 190./2.;
-  gMC->Gsvolu("MCBW", "TUBE", idtmed[890], tubpar, 3);
-  gMC->Gspos("MCBW", 1, "ZDC ", 0., 0., tubpar[2] + 1920., 0, "ONLY");
-  
-  // --  YOKE (IRON WITHOUT MAGNETIC FIELD) 
-  
-  tubpar[0] = 4.5;
-  tubpar[1] = 55.;
-  tubpar[2] = 190./2.;
-  gMC->Gsvolu("YMCB", "TUBE", idtmed[851], tubpar, 3);
-  gMC->Gspos("YMCB", 1, "ZDC ", 0., 0., tubpar[2] + 1920., 0, "ONLY");
-  
-  // -- INNER TRIPLET 
-  
-  zq = 2300.;
-  
-  // -- DEFINE MQXL AND MQX QUADRUPOLE ELEMENT 
-  
-  //     MQXL 
-  // --  GAP (VACUUM WITH MAGNETIC FIELD) 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 3.5;
-  tubpar[2] = 630./2.;
-  gMC->Gsvolu("MQXL", "TUBE", idtmed[890], tubpar, 3);
-  
-  // --  YOKE 
-  
-  tubpar[0] = 3.5;
-  tubpar[1] = 22.;
-  tubpar[2] = 630./2.;
-  gMC->Gsvolu("YMQL", "TUBE", idtmed[851], tubpar, 3);
-  
-  gMC->Gspos("MQXL", 1, "ZDC ", 0., 0., tubpar[2] + zq, 0, "ONLY");
-  gMC->Gspos("YMQL", 1, "ZDC ", 0., 0., tubpar[2] + zq, 0, "ONLY");
-  
-  gMC->Gspos("MQXL", 2, "ZDC ", 0., 0., tubpar[2] + zq + 2430., 0, "ONLY");
-  gMC->Gspos("YMQL", 2, "ZDC ", 0., 0., tubpar[2] + zq + 2430., 0, "ONLY");
-  
-  // --  MQX 
-  // --  GAP (VACUUM WITH MAGNETIC FIELD) 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 3.5;
-  tubpar[2] = 550./2.;
-  gMC->Gsvolu("MQX ", "TUBE", idtmed[890], tubpar, 3);
-  
-  // --  YOKE 
-  
-  tubpar[0] = 3.5;
-  tubpar[1] = 22.;
-  tubpar[2] = 550./2.;
-  gMC->Gsvolu("YMQ ", "TUBE", idtmed[851], tubpar, 3);
-  
-  gMC->Gspos("MQX ", 1, "ZDC ", 0., 0., tubpar[2] + zq + 880.,  0, "ONLY");
-  gMC->Gspos("YMQ ", 1, "ZDC ", 0., 0., tubpar[2] + zq + 880.,  0, "ONLY");
-  
-  gMC->Gspos("MQX ", 2, "ZDC ", 0., 0., tubpar[2] + zq + 1530., 0, "ONLY");
-  gMC->Gspos("YMQ ", 2, "ZDC ", 0., 0., tubpar[2] + zq + 1530., 0, "ONLY");
-  
-  // -- SEPARATOR DIPOLE D1 
-  
-  zd1 = 5843.5;
-  
-  // --  GAP (VACUUM WITH MAGNETIC FIELD) 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 4.5;
-  tubpar[2] = 945/2.;
-  gMC->Gsvolu("D1  ", "TUBE", idtmed[890], tubpar, 3);
-  
-  // --  YOKE 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 55.;
-  tubpar[2] = 945/2.;
-  gMC->Gsvolu("YD1 ", "TUBE", idtmed[851], tubpar, 3);
-  
-  gMC->Gspos("YD1 ", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  gMC->Gspos("D1  ", 1, "YD1 ", 0., 0., 0., 0, "ONLY");
-  
-  // -- DIPOLE D2 
-  
-  zd2 = 12113.2;
-  
-  // --  GAP (VACUUM WITH MAGNETIC FIELD) 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 4.5;
-  tubpar[2] = 945./2.;
-  gMC->Gsvolu("D2  ", "TUBE", idtmed[890], tubpar, 3);
-  
-  // --  YOKE 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 55.;
-  tubpar[2] = 945./2.;
-  gMC->Gsvolu("YD2 ", "TUBE", idtmed[851], tubpar, 3);
-  
-  gMC->Gspos("YD2 ", 1, "ZDC ", 0., 0., tubpar[2] + zd2, 0, "ONLY");
-  
-  gMC->Gspos("D2  ", 1, "YD2 ", -9.7, 0., 0., 0, "ONLY");
-  gMC->Gspos("D2  ", 2, "YD2 ",  9.7, 0., 0., 0, "ONLY");
-  
-  // -- END OF MAGNET DEFINITION 
-  
-  // ----------------- Hadronic calorimeters -------------------- * 
-  
-  // Neutron calorimeter 
-  
-  gMC->Gsvolu("ZNEU", "BOX ", idtmed[800], HDZN, 3); // Passive material  
-  gMC->Gsvolu("ZNFI", "TUBE", idtmed[802], FIZN, 3); // Active material
-  gMC->Gsvolu("ZNGR", "BOX ", idtmed[889], GRZN, 3); // Empty grooves 
-  
-  // Divide ZNEU in towers 
-  // (for hits purposes) 
-  
-  gMC->Gsdvn("ZNTX", "ZNEU", NZNTX, 1); // x-tower 
-  gMC->Gsdvn("ZN1 ", "ZNTX", NZNTY, 2); // y-tower
-  
-  // Divide ZNEU in minitowers 
-  // (NCEN(1)= NUMBER OF FIBERS PER TOWER ALONG X-AXIS, 
-  //  NCEN(2)= NUMBER OF FIBERS PER TOWER ALONG Y-AXIS) 
-  // (one fiber per minitower) 
-  
-  gMC->Gsdvn("ZNSL", "ZN1 ", NCEN[1], 2); // Slices 
-  gMC->Gsdvn("ZNST", "ZNSL", NCEN[0], 1); // Sticks
-  
-  // --- Position the empty grooves in the sticks 
-  gMC->Gspos("ZNGR", 1, "ZNST", 0., 0., 0., 0, "ONLY");
-  // --- Position the fibers in the grooves 
-  gMC->Gspos("ZNFI", 1, "ZNGR", 0., 0., 0., 0, "ONLY");
-  // --- Position the neutron calorimeter in ZDC 
-  gMC->Gspos("ZNEU", 1, "ZDC ", ZNPOS[0], ZNPOS[1], ZNPOS[2] + HDZN[2], 0, "ONLY");
-  
-  // Proton calorimeter 
-  
-  gMC->Gsvolu("ZPRO", "BOX ", idtmed[801], HDZP, 3); // Passive material
-  gMC->Gsvolu("ZPFI", "TUBE", idtmed[802], FIZP, 3); // Active material 
-  gMC->Gsvolu("ZPGR", "BOX ", idtmed[889], GRZP, 3); // Empty grooves
-  
-  // Divide ZPRO in towers 
-  // (for hits purposes) 
-  
-  gMC->Gsdvn("ZPTX", "ZPRO", NZPTX, 1); // x-tower 
-  gMC->Gsdvn("ZP1 ", "ZPTX", NZPTY, 2); // y-tower
-  
-  
-  // Divide ZPRO in minitowers 
-  // (NCEP[0]= NUMBER OF FIBERS ALONG X-AXIS PER MINITOWER, 
-  //  NCEP[1]= NUMBER OF FIBERS ALONG Y-AXIS PER MINITOWER) 
-  // (one fiber per minitower) 
-  
-  gMC->Gsdvn("ZPSL", "ZP1 ", NCEP[1], 2); // Slices 
-  gMC->Gsdvn("ZPST", "ZPSL", NCEP[0], 1); // Sticks
+  //
+  Float_t meanPed = calibPed->GetMeanPed(index);
+  Float_t pedWidth = calibPed->GetMeanPedWidth(index);
+  Float_t pedValue = gRandom->Gaus(meanPed,pedWidth);
+  //
+  //printf("\t AliZDC::Pedestal - det(%d, %d) - Ped[%d] = %d\n",Det, Quad, index,(Int_t) pedValue); // Chiara debugging!
   
   
-  // --- Position the empty grooves in the sticks 
-  gMC->Gspos("ZPGR", 1, "ZPST", 0., 0., 0., 0, "ONLY");
-  // --- Position the fibers in the grooves 
-  gMC->Gspos("ZPFI", 1, "ZPGR", 0., 0., 0., 0, "ONLY");
-  // --- Position the proton calorimeter in ZDC 
-  gMC->Gspos("ZPRO", 1, "ZDC ", ZPPOS[0], ZPPOS[1], ZPPOS[2] + HDZP[2], 0, "ONLY");
   
   
+
+  return (Int_t) pedValue;
 }
 }
+
+
 //_____________________________________________________________________________
 //_____________________________________________________________________________
-void AliZDCv1::DrawModule()
+Int_t AliZDC::ADCch2Phe(Int_t Det, Int_t Quad, Int_t ADCVal, Int_t Res) const
 {
 {
-  //
-  // Draw a shaded view of the Zero Degree Calorimeter version 1
-  //
+  // Evaluation of the no. of phe produced
+  Float_t pmGain[6][5];
+  Float_t resADC[2];
+  for(Int_t j = 0; j < 5; j++){
+    pmGain[0][j] = 50000.;
+    pmGain[1][j] = 100000.;
+    pmGain[2][j] = 100000.;
+    pmGain[3][j] = 50000.;
+    pmGain[4][j] = 100000.;
+    pmGain[5][j] = 100000.;
+  }
+  // ADC Caen V965
+  resADC[0] = 0.0000008; // ADC Resolution high gain: 200 fC/adcCh
+  resADC[1] = 0.0000064; // ADC Resolution low gain:  25  fC/adcCh
+  //
+  Int_t nPhe = (Int_t) (ADCVal / (pmGain[Det-1][Quad] * resADC[Res]));
+  //
+  //printf("\t AliZDC::ADCch2Phe -> det(%d, %d) - ADC %d  phe %d\n",Det,Quad,ADCVal,nPhe);
 
 
-  // Set everything unseen
-  gMC->Gsatt("*", "seen", -1);
-  // 
-  // Set ALIC mother transparent
-  gMC->Gsatt("ALIC","SEEN",0);
-  //
-  // Set the volumes visible
-  gMC->Gsatt("ZDC","SEEN",0);
-  gMC->Gsatt("P001","SEEN",1);
-  gMC->Gsatt("P002","SEEN",1);
-  gMC->Gsatt("P003","SEEN",1);
-  gMC->Gsatt("P004","SEEN",1);
-  gMC->Gsatt("P005","SEEN",1);
-  gMC->Gsatt("P006","SEEN",1);
-  gMC->Gsatt("P007","SEEN",1);
-  gMC->Gsatt("P008","SEEN",1);
-  gMC->Gsatt("P009","SEEN",1);
-  gMC->Gsatt("P010","SEEN",1);
-  gMC->Gsatt("P011","SEEN",1);
-  gMC->Gsatt("P012","SEEN",1);
-  gMC->Gsatt("P013","SEEN",1);
-  gMC->Gsatt("P014","SEEN",1);
-  gMC->Gsatt("P015","SEEN",1);
-  gMC->Gsatt("P016","SEEN",1);
-  gMC->Gsatt("P017","SEEN",1);
-  gMC->Gsatt("P018","SEEN",1);
-  gMC->Gsatt("P019","SEEN",1);
-  gMC->Gsatt("P020","SEEN",1);
-  gMC->Gsatt("P021","SEEN",1);
-  gMC->Gsatt("Q021","SEEN",1);
-  gMC->Gsatt("R021","SEEN",1);
-  gMC->Gsatt("P022","SEEN",1);
-  gMC->Gsatt("P023","SEEN",1);
-  gMC->Gsatt("D1  ","SEEN",1);
-  gMC->Gsatt("YD1 ","SEEN",1);
-  gMC->Gsatt("D2  ","SEEN",1);
-  gMC->Gsatt("YD2 ","SEEN",1);
-  gMC->Gsatt("MCBW","SEEN",1);
-  gMC->Gsatt("YMCB","SEEN",1);
-  gMC->Gsatt("MQXL","SEEN",1);
-  gMC->Gsatt("YMQL","SEEN",1);
-  gMC->Gsatt("MQX","SEEN",1);
-  gMC->Gsatt("YMQ","SEEN",1);
-  gMC->Gsatt("D1","SEEN",1);
-  gMC->Gsatt("YD1","SEEN",1);
-  gMC->Gsatt("D2","SEEN",1);
-  gMC->Gsatt("YD2","SEEN",1);
-  gMC->Gsatt("ZNEU","SEEN",0);
-  gMC->Gsatt("ZNFI","SEEN",0);
-  gMC->Gsatt("ZNGR","SEEN",0);
-  gMC->Gsatt("ZNTX","SEEN",0);
-  gMC->Gsatt("ZN1 ","COLO",2); 
-  gMC->Gsatt("ZN1 ","SEEN",1);
-  gMC->Gsatt("ZNSL","SEEN",0);
-  gMC->Gsatt("ZNST","SEEN",0);
-  gMC->Gsatt("ZPRO","SEEN",0);
-  gMC->Gsatt("ZPFI","SEEN",0);
-  gMC->Gsatt("ZPGR","SEEN",0);
-  gMC->Gsatt("ZPTX","SEEN",0);
-  gMC->Gsatt("ZP1 ","SEEN",1);
-  gMC->Gsatt("ZPSL","SEEN",0);
-  gMC->Gsatt("ZPST","SEEN",0);
-  
-  //
-  gMC->Gdopt("hide", "on");
-  gMC->Gdopt("shad", "on");
-  gMC->Gsatt("*", "fill", 7);
-  gMC->SetClipBox(".");
-  gMC->SetClipBox("*", 0, 100, -100, 100, 12000, 16000);
-  gMC->DefaultRange();
-  gMC->Gdraw("alic", 40, 30, 0, 488, 220, .07, .07);
-  gMC->Gdhead(1111, "Zero Degree Calorimeter Version 1");
-  gMC->Gdman(18, 4, "MAN");
+  return nPhe;
 }
 
 }
 
-//_____________________________________________________________________________
-void AliZDCv1::CreateMaterials()
-{
-  //
-  // Create Materials for the Zero Degree Calorimeter
-  //
-  // Origin    : E. Scomparin 
-  
-  Int_t *idtmed = fIdtmed->GetArray()-799;
-  
-  Float_t dens, ubuf[1], wmat[2];
-  Int_t isvol_active;
-  Float_t a[2];
-  Int_t i;
-  Float_t z[2], epsil=0.001, stmin=0.01;
-  Int_t isvol;
-  Float_t fieldm = gAlice->Field()->Max();
-  Int_t inofld;
-  Float_t deemax=-1;
-  Float_t tmaxfd=gAlice->Field()->Max();
-  Int_t isxfld = gAlice->Field()->Integ();
-  Float_t stemax;
-  
-  // --- Store in UBUF r0 for nuclear radius calculation R=r0*A**1/3 
-  
-  // --- Tungsten 
-  ubuf[0] = 1.11;
-  AliMaterial(1, "TUNG", 183.85, 74., 19.3, .35, 10.3, ubuf, 1);
-  
-  // --- Brass (CuZn) 
-  dens = 8.48;
-  a[0] = 63.546;
-  a[1] = 65.39;
-  z[0] = 29.;
-  z[1] = 30.;
-  wmat[0] = .63;
-  wmat[1] = .37;
-  AliMixture(2, "BRASS               ", a, z, dens, 2, wmat);
-  
-  // --- SiO2 
-  dens = 2.64;
-  a[0] = 28.086;
-  a[1] = 15.9994;
-  z[0] = 14.;
-  z[1] = 8.;
-  wmat[0] = 1.;
-  wmat[1] = 2.;
-  AliMixture(3, "SIO2                ", a, z, dens, -2, wmat);
-  
-  // --- Lead 
-  ubuf[0] = 1.12;
-  AliMaterial(4, "LEAD", 207.19, 82., 11.35, .56, 18.5, ubuf, 1);
-  
-  // --- Copper 
-  ubuf[0] = 1.1;
-  AliMaterial(5, "COPP", 63.54, 29., 8.96, 1.4, 0., ubuf, 1);
-  
-  // --- Tantalum 
-  ubuf[0] = 1.1;
-  AliMaterial(6, "TANT", 180.95, 73., 16.65, .4, 11.9, ubuf, 1);
-  
-  // Steel still to be added 
-  
-  // --- Iron 
-  ubuf[0] = 1.1;
-  AliMaterial(52, "IRON", 55.85, 26., 7.87, 1.76, 0., ubuf, 1);
-  
-  // --- Vacuum (no magnetic field) 
-  AliMaterial(90, "VOID", 1e-16, 1e-16, 1e-16, 1e16, 1e16, ubuf,0);
-  
-  // --- Vacuum (magnetic field) 
-  AliMaterial(91, "VOIM", 1e-16, 1e-16, 1e-16, 1e16, 1e16, ubuf,0);
-  
-  // --- Air non magnetic 
-  AliMaterial(92, "Air    $", 14.61, 7.3, .001205, 30420., 67500., ubuf, 0);
-  
-  // ---  Definition of tracking media: 
-  
-  // --- Tungsten = 801 ; 
-  // --- Brass = 802 ; 
-  // --- Fibers (SiO2) = 803 ; 
-  // --- Lead = 804 ; 
-  // --- Copper = 805 ; 
-  // --- Tantalum = 806 ; 
-  // --- Steel = 851 ; 
-  // --- Iron = 852 ; 
-  // --- Vacuum (no field) = 890 
-  // --- Vacuum (with field) = 891 
-  // --- Air   (no field) = 892 
-  
-  
-  // --- Tracking media parameters 
-  epsil  = .01;
-  stemax = 1.;
-  isvol  = 0;
-  isvol_active = 1;
-  inofld = 0;
-  fieldm = 0.;
-  
-  AliMedium(1, "ZW", 1, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(2, "ZBRASS", 2, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(3, "ZSIO2", 3, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(4, "ZLEAD", 4, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(5, "ZCOPP", 5, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(6, "ZTANT", 6, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(52, "ZIRON", 52, isvol, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(90, "ZVOID", 90, isvol, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(92, "Air", 92, 0, inofld, fieldm, tmaxfd, stemax,deemax, epsil, stmin);
-  
-  fieldm = 45.;
-  //    AliMedium(91, "ZVOIM", 91, isvol, isxfld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(91, "ZVOIM", 91, isvol, isxfld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  
-  // Thresholds for showering in the ZDCs 
-  
-  i = 801;
-  gMC->Gstpar(idtmed[i-1], "CUTGAM", .01);
-  gMC->Gstpar(idtmed[i-1], "CUTELE", .01);
-  gMC->Gstpar(idtmed[i-1], "CUTNEU", .1);
-  gMC->Gstpar(idtmed[i-1], "CUTHAD", .1);
-  i = 802;
-  gMC->Gstpar(idtmed[i-1], "CUTGAM", .01);
-  gMC->Gstpar(idtmed[i-1], "CUTELE", .01);
-  gMC->Gstpar(idtmed[i-1], "CUTNEU", .1);
-  gMC->Gstpar(idtmed[i-1], "CUTHAD", .1);
-  
-  // Avoid too detailed showering along the beam line 
-  
-  i = 852;
-  gMC->Gstpar(idtmed[i-1], "CUTGAM", .1);
-  gMC->Gstpar(idtmed[i-1], "CUTELE", .1);
-  gMC->Gstpar(idtmed[i-1], "CUTNEU", 1.);
-  gMC->Gstpar(idtmed[i-1], "CUTHAD", 1.);
-  
-  // Avoid interaction in fibers (only energy loss allowed) 
-  i = 803;
-  gMC->Gstpar(idtmed[i-1], "DCAY", 0.);
-  gMC->Gstpar(idtmed[i-1], "MULS", 0.);
-  gMC->Gstpar(idtmed[i-1], "PFIS", 0.);
-  gMC->Gstpar(idtmed[i-1], "MUNU", 0.);
-  gMC->Gstpar(idtmed[i-1], "LOSS", 1.);
-  gMC->Gstpar(idtmed[i-1], "PHOT", 0.);
-  gMC->Gstpar(idtmed[i-1], "COMP", 0.);
-  gMC->Gstpar(idtmed[i-1], "PAIR", 0.);
-  gMC->Gstpar(idtmed[i-1], "BREM", 0.);
-  gMC->Gstpar(idtmed[i-1], "DRAY", 0.);
-  gMC->Gstpar(idtmed[i-1], "ANNI", 0.);
-  gMC->Gstpar(idtmed[i-1], "HADR", 0.);
+//______________________________________________________________________
+void AliZDC::SetTreeAddress(){
+
+  // Set branch address for the Trees.
+  if(fLoader->TreeH() && (fHits == 0x0))
+    fHits   = new TClonesArray("AliZDCHit",1000);
+      
+  AliDetector::SetTreeAddress();
 }
 
 }
 
-ClassImp(AliZDChit)
-  
 //_____________________________________________________________________________
 //_____________________________________________________________________________
-AliZDChit::AliZDChit(Int_t shunt, Int_t track, Int_t *vol, Float_t *hits):
-  AliHit(shunt, track)
+AliZDCChMap* AliZDC::GetChMap() const
 {
 {
-  //
-  // Add a Zero Degree Calorimeter hit
-  //
-  Int_t i;
-  for (i=0;i<4;i++) fVolume[i] = vol[i];
-  fX=hits[0];
-  fY=hits[1];
-  fZ=hits[2];
-  fEnergy=hits[3];
+
+  // Getting calibration object for ZDC
+
+  AliCDBEntry  *entry = AliCDBManager::Instance()->Get("ZDC/Calib/ChMap");
+  if(!entry) AliFatal("No calibration data loaded!");  
+
+  AliZDCChMap *calibdata = dynamic_cast<AliZDCChMap*> (entry->GetObject());
+  if(!calibdata) AliFatal("Wrong calibration object in calibration  file!");
+
+  return calibdata;
 }
 }