]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - ZDC/AliZDC.cxx
Merging and reconstruction code review
[u/mrichter/AliRoot.git] / ZDC / AliZDC.cxx
index 6f488a468f1d4aceb1f6c5269715ac7f5e1035fa..aad66cdb8ff17de8f68aeea065a84bbac03143a0 100644 (file)
-///////////////////////////////////////////////////////////////////////////////
-//                                                                           //
-//  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
+/**************************************************************************
+ * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ *                                                                        *
+ * Author: The ALICE Off-line Project.                                    *
+ * Contributors are mentioned in the code where appropriate.              *
+ *                                                                        *
+ * Permission to use, copy, modify and distribute this software and its   *
+ * documentation strictly for non-commercial purposes is hereby granted   *
+ * without fee, provided that the above copyright notice appears in all   *
+ * copies and that both the copyright notice and this permission notice   *
+ * appear in the supporting documentation. The authors make no claims     *
+ * about the suitability of this software for any purpose. It is          *
+ * provided "as is" without express or implied warranty.                  *
+ **************************************************************************/
+
 /*
-<img src="gif/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>
+$Log$
+Revision 1.26.2.2  2001/11/12 18:41:44  hristov
+All the changes from the head are merged to the release
+
+Revision 1.27  2001/10/21 18:27:45  hristov
+Several pointers were set to zero in the default constructors to avoid memory management problems
+
+Revision 1.26  2001/10/04 14:30:28  coppedis
+Event merging for ZDC
+
+Revision 1.25  2001/10/04 14:24:15  coppedis
+Event merging for ZDC
+
+Revision 1.24  2001/09/26 16:03:41  coppedis
+Merging implemented
+
+Revision 1.23  2001/05/15 13:44:57  coppedis
+Changes in AddHit method
+
+Revision 1.22  2001/05/14 09:53:32  coppedis
+Adding functions ZMin and ZMax
+
+Revision 1.21  2001/04/20 10:05:02  coppedis
+Minor changes
+
+Revision 1.20  2001/03/26 13:39:20  coppedis
+Comment prints
+
+Revision 1.19  2001/03/26 09:10:23  coppedis
+Corrected bug in constructor (fIshunt has to be =1)
+
+Revision 1.18  2001/03/20 08:21:55  coppedis
+ZDC needs PIPE, ABSO, DIPO and SHIL
+
+Revision 1.17  2001/03/16 16:18:03  coppedis
+Correction for superposition of ZDC volumes with MUON arm one
+
+Revision 1.16  2001/03/15 16:01:11  coppedis
+Code review
+
+Revision 1.15  2001/01/26 19:56:27  hristov
+Major upgrade of AliRoot code
+
+Revision 1.14  2000/12/12 13:17:01  coppedis
+Minor corrections suggested by P. Hristov
+
+Revision 1.12  2000/12/01 08:19:01  coppedis
+Adding a message error if ZDC is constructed without DIPO
+
+Revision 1.11  2000/11/30 17:21:03  coppedis
+Introduce hit array fStHits reset only at the end of the event (for digitization)
+
+Revision 1.10  2000/11/22 11:32:58  coppedis
+Major code revision
+
+Revision 1.9  2000/10/02 21:28:20  fca
+Removal of useless dependecies via forward declarations
+
+Revision 1.8  2000/07/10 13:58:01  fca
+New version of ZDC from E.Scomparin & C.Oppedisano
+
+Revision 1.7  2000/01/19 17:17:40  fca
+
+Revision 1.6  1999/09/29 09:24:35  fca
+Introduction of the Copyright and cvs Log
+
 */
-//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 <stdlib.h>
+#include <iostream.h>
+
+// --- ROOT system
 #include <TBRIK.h>
 #include <TNode.h>
+#include <TGeometry.h>
+#include <TFile.h>
+#include <TTree.h>
+#include <TDirectory.h>
+#include <TF1.h>
 
+// --- AliRoot header files
 #include "AliZDC.h"
-#include "AliRun.h"
+#include "AliZDCHit.h"
+#include "AliZDCMergedHit.h"
+#include "AliZDCMerger.h"
+#include "AliZDCDigit.h"
+#include "AliZDCReco.h"
+#include "AliDetector.h"
 #include "AliCallf77.h"
 #include "AliConst.h"
 #include "AliMC.h"
+#include "AliRun.h"
+#include "AliHeader.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)
  
@@ -66,7 +126,24 @@ AliZDC::AliZDC()
   //
   // Default constructor for the Zero Degree Calorimeter base class
   //
-  fIshunt   = 0;
+  
+  fIshunt     = 1;
+  fNoShower   = 0;
+  fMerger     = 0;
+
+  fHits       = 0;
+  fNhits      = 0;
+
+  fDigits     = 0;
+  fNdigits    = 0;
+
+  fMergedHits = 0;
+  fTreeSD     = 0;
+  fTreeMD     = 0;
+
+  fNRecPoints = 0;
+  fRecPoints  = 0;
+  
 }
  
 //_____________________________________________________________________________
@@ -77,23 +154,119 @@ AliZDC::AliZDC(const char *name, const char *title)
   // Standard constructor for the Zero Degree Calorimeter base class
   //
 
+  fIshunt   = 1;
+  fNoShower = 0;
+  fMerger   = 0;
+
+  // Allocate the hits array  
+  fHits   = new TClonesArray("AliZDCHit",1000);
+  gAlice->AddHitList(fHits);
+  // Allocate the merged hits array  
+  fMergedHits = new TClonesArray("AliZDCMergedHit",1000);
+
+  // Allocate the digits array  
+  fDigits = new TClonesArray("AliZDCDigit",1000);
+  
+  fTreeSD = 0;
+  fTreeMD = 0;
+
+  fNRecPoints = 0;
+  fRecPoints = 0;  
+
+}
+//____________________________________________________________________________ 
+AliZDC::~AliZDC()
+{
   //
-  // Allocate the array of hits
-  fHits   = new TClonesArray("AliZDChit",  405);
+  // ZDC destructor
+  //
+
+  fIshunt   = 0;
   
-  fIshunt     =  1;
+  if(fMerger) delete fMerger;
+
+//  if(fHits){
+//    fHits->Delete();
+//    delete fHits;
+//  }
+
+//  if(fDigits){
+//    fDigits->Delete();
+//    delete fDigits;
+//  }
+
 }
 //_____________________________________________________________________________
 void AliZDC::AddHit(Int_t track, Int_t *vol, Float_t *hits)
 {
   //
-  // Add a Zero Degree Calorimeter hit
+  //           Add a ZDC hit to the hit list.
+  // -> We make use of 2 array of hits:
+  // [1]  fHits (the usual one) that contains hits for each PRIMARY
+  // [2]  fStHits that contains hits for each EVENT and is used to
+  //     obtain digits at the end of each event
   //
+  
+  static Float_t primKinEn, xImpact, yImpact, sFlag;
+
+  AliZDCHit *newquad, *curprimquad;
+  newquad = new AliZDCHit(fIshunt, track, vol, hits);
   TClonesArray &lhits = *fHits;
-  new(lhits[fNhits++]) AliZDChit(fIshunt,track,vol,hits);
-}
+  
+  if(fNhits==0){
+      // First hit -> setting flag for primary or secondary particle
+      Int_t primary = gAlice->GetPrimary(track);     
+      if(track != primary){
+        newquad->fSFlag = 1;  // SECONDARY particle entering the ZDC
+      }
+      else if(track == primary){
+        newquad->fSFlag = 0;  // PRIMARY particle entering the ZDC
+      }  
+//      fNPrimaryHits += 1;
+      sFlag    = newquad->fSFlag;
+      primKinEn = newquad->fPrimKinEn;
+      xImpact  = newquad->fXImpact;
+      yImpact  = newquad->fYImpact;
+   }
+   else{       
+      newquad->fPrimKinEn = primKinEn;
+      newquad->fXImpact        = xImpact;
+      newquad->fYImpact = yImpact;
+      newquad->fSFlag  = sFlag;
+   }
  
+  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;
+       delete newquad;
+       return;
+     } 
+  }
+
+    //Otherwise create a new hit
+    new(lhits[fNhits]) AliZDCHit(newquad);
+    fNhits++;
+    
+    delete newquad;
+}
+
+//_____________________________________________________________________________
+void  AliZDC::AddDigit(Int_t *sect, Int_t digit)
+{
+//
+  AliZDCDigit *newdigit;
+  newdigit = new AliZDCDigit(sect, digit);
+  
+//  printf("\n AddDigit -> sector[0] = %d, sector[1] = %d, digit = %d",
+//         sect[0], sect[1], digit);
+  new((*fDigits)[fNdigits]) AliZDCDigit(*newdigit);
+  fNdigits++;
+  delete newdigit;
+}
+      
 //_____________________________________________________________________________
 void AliZDC::BuildGeometry()
 {
@@ -103,21 +276,19 @@ void AliZDC::BuildGeometry()
   // This routine is dummy for the moment
   //
 
-  //  TNode *Node, *Top;
-  //  TBRIK *brik;
-  //  const int kColorZDC  = kRed;
+  TNode *node, *top;
+  TBRIK *brik;
+  const int kColorZDC  = kBlue;
   
   //
-  // Top=gAlice->GetGeometry()->GetNode("alice");
+  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);
-  */
+    top->cd();
+    node = new TNode("ZDC","ZDC","S_ZDC",0,0,600,"");
+    node->SetLineColor(kColorZDC);
+    fNodes->Add(node);
 }
 
 //_____________________________________________________________________________
@@ -129,834 +300,448 @@ Int_t AliZDC::DistancetoPrimitive(Int_t , Int_t )
   //
   return 9999;
 }
-//_____________________________________________________________________________
-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)
+
+//____________________________________________________________________________
+Float_t AliZDC::ZMin(void) const
 {
-  //
-  // Set beam characteristic
-  // 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.;
+}
 
-  // 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);
+//____________________________________________________________________________
+Float_t AliZDC::ZMax(void) const
+{
+  // Maximum dimension of the ZDC module in z
+  return  11750.;
 }
+  
 
 //_____________________________________________________________________________
-void AliZDC::SetHijing(Int_t hij, Int_t hijf, Int_t hijsp, const char *file)
+ void AliZDC::MakeBranch(Option_t *opt, const char *file)
 {
   //
-  // 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
+  // Create Tree branches for the ZDC
   //
 
-  // 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));
+  char branchname[10];
+  sprintf(branchname,"%s",GetName());
+  
+  AliDetector::MakeBranch(opt);
+
+  const char *cS = strstr(opt,"S");
+
+  if (gAlice->TreeS() && cS) {
+    if(fMergedHits!=0) fMergedHits->Clear();
+    else fMergedHits = new TClonesArray ("AliZDCMergedHit",1000);
+    MakeBranchInTree(gAlice->TreeS(), 
+                     branchname, &fMergedHits, fBufferSize, file) ;
+    printf("* AliZDC::MakeBranch    * Making Branch %s for SDigits\n\n",branchname);
+  }
+
+    
+  const char *cD = strstr(opt,"D");
+
+  if (gAlice->TreeD() && cD) {
+    if(fDigits!=0) fDigits->Clear();
+    else fDigits = new TClonesArray ("AliZDCDigit",1000);
+    MakeBranchInTree(gAlice->TreeD(), 
+                     branchname, &fDigits, fBufferSize, file) ;
+    printf("* AliZDC::MakeBranch    * Making Branch %s for Digits\n\n",branchname);
+  }
+
+  
+  const char *cR = strstr(opt,"R");
+
+  if (gAlice->TreeR() && cR) {
+    MakeBranchInTree(gAlice->TreeR(), 
+                    branchname, &fRecPoints, fBufferSize, file) ;
+    printf("* AliZDC::MakeBranch    * Making Branch %s for RecPoints\n\n",branchname);   }
+          
 }
 
 //_____________________________________________________________________________
-void AliZDC::SetVenus(Int_t hiv, Int_t hivf, Int_t hivsp, const char *file)
+ void AliZDC::MakeBranchInTreeSD(TTree *treeSD, const char *file)
 {
-  //
-  // 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
-  //
+  // MakeBranchInTree
+  const Int_t kBufferSize = 4000;
+  char  branchname[20];
+  sprintf(branchname,"%s",GetName());
+  MakeBranchInTree(treeSD, branchname, &fMergedHits, kBufferSize, file) ;
+  printf("* AliZDC::MakeBranch    * Making Branch %s for SDigits\n\n",branchname);
 
-  // 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));
 }
-
 //_____________________________________________________________________________
-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::MakeBranchInTreeD(TTree *treeD, const char *file)
 {
-  //
-  // 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
-  //
+  // MakeBranchInTree
+  const Int_t kBufferSize = 4000;
+  char  branchname[20];
+  sprintf(branchname,"%s",GetName());
+  MakeBranchInTree(treeD, branchname, &fDigits, kBufferSize, file) ;
+  printf("* AliZDC::MakeBranch    * Making Branch %s for Digits\n\n",branchname);
 
-  // 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);
 }
 //_____________________________________________________________________________
-void AliZDC::StepManager()
+ void AliZDC::MakeBranchInTreeR(TTree *treeR, const char *file)
 {
-  //
-  // 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();
+  // MakeBranchInTree
+  const Int_t kBufferSize = 4000;
+  char  branchname[20];
+  sprintf(branchname,"%s",GetName());
+  MakeBranchInTree(treeR, branchname, &fRecPoints, kBufferSize, file) ;
+  printf("* AliZDC::MakeBranch    * Making Branch %s for RecPoints\n\n",branchname);
+
 }
+//_____________________________________________________________________________
+void AliZDC::Hits2SDigits()
+{
+  printf("\n   Entering AliZDC::SDigits2Digits() ");
+  
+  //----------------------------------------------------------------
+  if(!fMerger){ 
+    printf("   ZDC digitization (without merging)\n");
 
-ClassImp(AliZDCv1)
+    AliZDCMergedHit *MHit;
+    Int_t j, sector[2];
+    Float_t MHits[7];
+    fNMergedhits = 0;
 
-///////////////////////////////////////////////////////////////////////////////
-//                                                                           //
-//  Zero Degree Calorimeter version 1                                        //
-//                                                                           //
-//Begin_Html
-/*
-<img src="gif/AliZDCv1Class.gif">
-*/
-//End_Html
-//                                                                           //
-//                                                                           //
-///////////////////////////////////////////////////////////////////////////////
+    TTree *treeH = gAlice->TreeH();
+    Int_t ntracks = (Int_t) treeH->GetEntries();
+    gAlice->ResetHits();
+  
+    // Tracks loop
+    for(Int_t itrack=0; itrack<ntracks; itrack++){
+       treeH->GetEvent(itrack);
+       for(AliZDCHit* zdcHit=(AliZDCHit*)this->FirstHit(-1); zdcHit;
+                      zdcHit = (AliZDCHit*)this->NextHit()){ 
+                     
+          for(j=0; j<2; j++) sector[j] = zdcHit->GetVolume(j);
+          MHits[0] = zdcHit->GetPrimKinEn();
+          MHits[1] = zdcHit->GetXImpact();
+          MHits[2] = zdcHit->GetYImpact();
+          MHits[3] = zdcHit->GetSFlag();
+          MHits[4] = zdcHit->GetLightPMQ();
+          MHits[5] = zdcHit->GetLightPMC();
+          MHits[6] = zdcHit->GetEnergy();
+       }//Hits loop
+       
+         MHit = new AliZDCMergedHit(sector, MHits);
+         new((*fMergedHits)[fNMergedhits]) AliZDCMergedHit(*MHit);       
+         TClonesArray &sdigits = *fMergedHits;
+         new (sdigits[fNMergedhits]) AliZDCMergedHit(*MHit);
+         fNMergedhits++;
+         delete MHit;
+    }
+//    printf("\n       ### Filling SDigits tree\n");
+    gAlice->TreeS()->Fill();
+    gAlice->TreeS()->Write(0,TObject::kOverwrite);  
+    gAlice->TreeS()->Reset();  
+  }
+  //----------------------------------------------------------------
+  else if(fMerger){
+    printf("   ZDC merging and digitization\n");
+    // ### Initialise merging
+    fMerger -> InitMerging();
 
-//_____________________________________________________________________________
-AliZDCv1::AliZDCv1() : AliZDC()
-{
-  //
-  // Default constructor for Zero Degree Calorimeter
-  //
+    TFile *bgrFile  = fMerger->BgrFile();
+    bgrFile->cd();
+    // SDigits tree
+    Int_t fNEvBgr = fMerger->EvNum();
+    char treeSDBgrName[20];
+    sprintf(treeSDBgrName,"TreeS%d",fNEvBgr);
+    fTreeSD = (TTree*)gDirectory->Get(treeSDBgrName); // TreeH
+    if(!fTreeSD){
+      printf("\n ERROR -> Can't find TreeS%d in background file\n",fNEvBgr);
+    }   
+    // Branch address
+    char branchSDname[20];
+    sprintf(branchSDname,"%s",GetName());
+    if(fTreeSD && fMergedHits){
+      TBranch *branchSD = fTreeSD->GetBranch(branchSDname);
+      if(branchSD) branchSD->SetAddress(&fMergedHits);
+      else if(!branchSD) MakeBranchInTreeSD(fTreeSD);
+    }
+
+    // ### Get TCA of MergedHits from AliZDCMerger
+    fMergedHits  = fMerger->MergedHits();
+    fNMergedhits = fMerger->GetNMhits();
+//    printf("\n         fNMergedhits (from AliZDCMerger) = %d\n", fNMergedhits);   
+    AliZDCMergedHit *MHit;
+    TClonesArray &sdigits = *fMergedHits;
+    Int_t imhit;
+    //Merged Hits loop
+    for(imhit=0; imhit<fNMergedhits; imhit++){
+       MHit = (AliZDCMergedHit*) fMergedHits->UncheckedAt(imhit);
+       new (sdigits[imhit]) AliZDCMergedHit(*MHit);
+    }
+
+//    printf("\n ### Filling SDigits tree\n");
+    bgrFile->cd();
+    fTreeSD->Fill();
+    fTreeSD->Write(0,TObject::kOverwrite);
+  }
+  
 }
+
 //_____________________________________________________________________________
-AliZDCv1::AliZDCv1(const char *name, const char *title)
-  : AliZDC(name,title)
+void AliZDC::SDigits2Digits()
 {
-  //
-  // Standard constructor for Zero Degree Calorimeter 
-  //
+  //printf("\n Entering AliZDC::SDigits2Digits() ");
+  if(!fMerger){ // Only digitization
+    printf("   ZDC digitization (without merging) \n");
+    fMerger = new AliZDCMerger();    
+    fMerger->Digitize(fNMergedhits, fMergedHits);
+
+    char hname[30];
+    sprintf(hname,"TreeD%d",gAlice->GetHeader()->GetEvent());
+    gAlice->TreeD()->Fill();
+    gAlice->TreeD()->Write(0,TObject::kOverwrite);
+    gAlice->TreeD()->Reset();  
+  }
+  else if(fMerger){    // Merging and digitization
+    printf("   ZDC merging and digitization\n");
+    fMerger->Digitize(fNMergedhits, fMergedHits);
+
+    TFile *bgrFile = fMerger->BgrFile();
+    bgrFile->cd();
+    // Digits tree
+    Int_t fNEvBgr = fMerger->EvNum();
+    //printf(" fNEvBgr = %d\n",fNEvBgr);
+    char treeDBgrName[20];
+    sprintf(treeDBgrName,"TreeD%d",fNEvBgr);
+    fTreeMD = (TTree*)gDirectory->Get(treeDBgrName); // TreeH
+    if(!fTreeMD){
+      printf("\n ERROR -> Can't find TreeD%d in background file\n",fNEvBgr);
+    }   
+    // Branch address
+    char branchDname[20];
+    sprintf(branchDname,"%s",GetName());
+    if(fTreeMD && fDigits){
+//      printf("\n     fTreeMD!=0 && fDigits!=0\n");
+      TBranch *branchD = fTreeMD->GetBranch(branchDname);
+      if(branchD) branchD->SetAddress(&fDigits);
+      else if(!branchD) MakeBranchInTreeD(fTreeMD);
+    }
+    
+    fTreeMD->Fill();
+    fTreeMD->Write(0,TObject::kOverwrite);
+  }
+  
+  
 }
 //_____________________________________________________________________________
-void AliZDCv1::CreateGeometry()
+void AliZDC::Hits2Digits()
 {
-  //
-  // Create the geometry for the Zero Degree Calorimeter version 1
-  // -- Author :    E Scomparin
-  //
-  //Begin_Html
-  /*
-    <img src="gif/AliZDCv1.gif">
-  */
-  //End_Html
-  //Begin_Html
-  /*
-    <img src="gif/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
-  //*
-  
-  AliMC* pMC = AliMC::GetMC();
-  
-  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 = gAlice->Idtmed();
-  
-  // -- 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.;
-  pMC->Gsvolu("ZDC ", "PCON", idtmed[891], conpar, 9);
-  pMC->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;
-  pMC->Gsvolu("P001", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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;
-  pMC->Gsvolu("P002", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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;
-  pMC->Gsvolu("P003", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P004", "CONE", idtmed[851], conpar, 5);
-  pMC->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.;
-  pMC->Gsvolu("P005", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P006", "CONE", idtmed[851], conpar, 5);
-  pMC->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.;
-  pMC->Gsvolu("P007", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P008", "CONE", idtmed[851], conpar, 5);
-  pMC->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.;
-  pMC->Gsvolu("P009", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P010", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P011", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P012", "CONE", idtmed[851], conpar, 5);
-  pMC->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.;
-  pMC->Gsvolu("P013", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P014", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P015", "CONE", idtmed[851], conpar, 5);
-  pMC->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.;
-  pMC->Gsvolu("P016", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P017", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P018", "CONE", idtmed[851], conpar, 5);
-  pMC->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.;
-  pMC->Gsvolu("P019", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P020", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("P021", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("Q021", "TUBE", idtmed[889], tubpar, 3);
-  tubpar[0] = 0.;
-  tubpar[1] = 7.0/2.;
-  tubpar[2] = 0.2/2.;
-  pMC->Gsvolu("R021", "TUBE", idtmed[889], tubpar, 3);
-  // -- POSITION Q021 INSIDE P021 
-  pMC->Gspos("Q021", 1, "P021", -7.7, 0., 0., 0, "ONLY");
-  // -- POSITION R020 INSIDE P020 
-  pMC->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;
-  pMC->Gsvolu("P022", "TUBE", idtmed[851], tubpar, 3);
-  tubpar[0] = 7.0/2.;
-  tubpar[1] = 7.4/2.;
-  tubpar[2] = 645.*0.5;
-  pMC->Gsvolu("P023", "TUBE", idtmed[851], tubpar, 3);
-  
-  // -- ROTATE PIPES 
-  AliMatrix(im1, 90.-0.071, 0., 90., 90., .071, 180.);
-  angle = .071*kDegrad;
-  pMC->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.);
-  pMC->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.;
-  pMC->Gsvolu("MCBW", "TUBE", idtmed[890], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("YMCB", "TUBE", idtmed[851], tubpar, 3);
-  pMC->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.;
-  pMC->Gsvolu("MQXL", "TUBE", idtmed[890], tubpar, 3);
-  
-  // --  YOKE 
-  
-  tubpar[0] = 3.5;
-  tubpar[1] = 22.;
-  tubpar[2] = 630./2.;
-  pMC->Gsvolu("YMQL", "TUBE", idtmed[851], tubpar, 3);
-  
-  pMC->Gspos("MQXL", 1, "ZDC ", 0., 0., tubpar[2] + zq, 0, "ONLY");
-  pMC->Gspos("YMQL", 1, "ZDC ", 0., 0., tubpar[2] + zq, 0, "ONLY");
-  
-  pMC->Gspos("MQXL", 2, "ZDC ", 0., 0., tubpar[2] + zq + 2430., 0, "ONLY");
-  pMC->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.;
-  pMC->Gsvolu("MQX ", "TUBE", idtmed[890], tubpar, 3);
-  
-  // --  YOKE 
-  
-  tubpar[0] = 3.5;
-  tubpar[1] = 22.;
-  tubpar[2] = 550./2.;
-  pMC->Gsvolu("YMQ ", "TUBE", idtmed[851], tubpar, 3);
-  
-  pMC->Gspos("MQX ", 1, "ZDC ", 0., 0., tubpar[2] + zq + 880.,  0, "ONLY");
-  pMC->Gspos("YMQ ", 1, "ZDC ", 0., 0., tubpar[2] + zq + 880.,  0, "ONLY");
-  
-  pMC->Gspos("MQX ", 2, "ZDC ", 0., 0., tubpar[2] + zq + 1530., 0, "ONLY");
-  pMC->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.;
-  pMC->Gsvolu("D1  ", "TUBE", idtmed[890], tubpar, 3);
-  
-  // --  YOKE 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 55.;
-  tubpar[2] = 945/2.;
-  pMC->Gsvolu("YD1 ", "TUBE", idtmed[851], tubpar, 3);
-  
-  pMC->Gspos("YD1 ", 1, "ZDC ", 0., 0., tubpar[2] + zd1, 0, "ONLY");
-  pMC->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.;
-  pMC->Gsvolu("D2  ", "TUBE", idtmed[890], tubpar, 3);
-  
-  // --  YOKE 
-  
-  tubpar[0] = 0.;
-  tubpar[1] = 55.;
-  tubpar[2] = 945./2.;
-  pMC->Gsvolu("YD2 ", "TUBE", idtmed[851], tubpar, 3);
-  
-  pMC->Gspos("YD2 ", 1, "ZDC ", 0., 0., tubpar[2] + zd2, 0, "ONLY");
-  
-  pMC->Gspos("D2  ", 1, "YD2 ", -9.7, 0., 0., 0, "ONLY");
-  pMC->Gspos("D2  ", 2, "YD2 ",  9.7, 0., 0., 0, "ONLY");
-  
-  // -- END OF MAGNET DEFINITION 
-  
-  // ----------------- Hadronic calorimeters -------------------- * 
-  
-  // Neutron calorimeter 
-  
-  pMC->Gsvolu("ZNEU", "BOX ", idtmed[800], HDZN, 3); // Passive material  
-  pMC->Gsvolu("ZNFI", "TUBE", idtmed[802], FIZN, 3); // Active material
-  pMC->Gsvolu("ZNGR", "BOX ", idtmed[889], GRZN, 3); // Empty grooves 
-  
-  // Divide ZNEU in towers 
-  // (for hits purposes) 
-  
-  pMC->Gsdvn("ZNTX", "ZNEU", NZNTX, 1); // x-tower 
-  pMC->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) 
-  
-  pMC->Gsdvn("ZNSL", "ZN1 ", NCEN[1], 2); // Slices 
-  pMC->Gsdvn("ZNST", "ZNSL", NCEN[0], 1); // Sticks
-  
-  // --- Position the empty grooves in the sticks 
-  pMC->Gspos("ZNGR", 1, "ZNST", 0., 0., 0., 0, "ONLY");
-  // --- Position the fibers in the grooves 
-  pMC->Gspos("ZNFI", 1, "ZNGR", 0., 0., 0., 0, "ONLY");
-  // --- Position the neutron calorimeter in ZDC 
-  pMC->Gspos("ZNEU", 1, "ZDC ", ZNPOS[0], ZNPOS[1], ZNPOS[2] + HDZN[2], 0, "ONLY");
-  
-  // Proton calorimeter 
-  
-  pMC->Gsvolu("ZPRO", "BOX ", idtmed[801], HDZP, 3); // Passive material
-  pMC->Gsvolu("ZPFI", "TUBE", idtmed[802], FIZP, 3); // Active material 
-  pMC->Gsvolu("ZPGR", "BOX ", idtmed[889], GRZP, 3); // Empty grooves
-  
-  // Divide ZPRO in towers 
-  // (for hits purposes) 
-  
-  pMC->Gsdvn("ZPTX", "ZPRO", NZPTX, 1); // x-tower 
-  pMC->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) 
-  
-  pMC->Gsdvn("ZPSL", "ZP1 ", NCEP[1], 2); // Slices 
-  pMC->Gsdvn("ZPST", "ZPSL", NCEP[0], 1); // Sticks
-  
-  // --- Position the empty grooves in the sticks 
-  pMC->Gspos("ZPGR", 1, "ZPST", 0., 0., 0., 0, "ONLY");
-  // --- Position the fibers in the grooves 
-  pMC->Gspos("ZPFI", 1, "ZPGR", 0., 0., 0., 0, "ONLY");
-  // --- Position the proton calorimeter in ZDC 
-  pMC->Gspos("ZPRO", 1, "ZDC ", ZPPOS[0], ZPPOS[1], ZPPOS[2] + HDZP[2], 0, "ONLY");
-  
+    gAlice->Hits2SDigits();
+    gAlice->SDigits2Digits();
 }
+
 //_____________________________________________________________________________
-void AliZDCv1::DrawModule()
+void AliZDC::Digits2Reco()
 {
-  //
-  // Draw a shaded view of the Zero Degree Calorimeter version 1
-  //
+  //printf("\n Entering AliZDC::Digits2Reco() ");
+    
+    Int_t fNEvBgr = fMerger->EvNum();
+    //printf(" fNEvBgr = %d\n",fNEvBgr);
+    gAlice->GetEvent(fNEvBgr);
 
-  AliMC* pMC = AliMC::GetMC();
-  
-  // Set everything unseen
-  pMC->Gsatt("*", "seen", -1);
-  // 
-  // Set ALIC mother transparent
-  pMC->Gsatt("ALIC","SEEN",0);
-  //
-  // Set the volumes visible
-  pMC->Gsatt("ZDC","SEEN",0);
-  pMC->Gsatt("P001","SEEN",1);
-  pMC->Gsatt("P002","SEEN",1);
-  pMC->Gsatt("P003","SEEN",1);
-  pMC->Gsatt("P004","SEEN",1);
-  pMC->Gsatt("P005","SEEN",1);
-  pMC->Gsatt("P006","SEEN",1);
-  pMC->Gsatt("P007","SEEN",1);
-  pMC->Gsatt("P008","SEEN",1);
-  pMC->Gsatt("P009","SEEN",1);
-  pMC->Gsatt("P010","SEEN",1);
-  pMC->Gsatt("P011","SEEN",1);
-  pMC->Gsatt("P012","SEEN",1);
-  pMC->Gsatt("P013","SEEN",1);
-  pMC->Gsatt("P014","SEEN",1);
-  pMC->Gsatt("P015","SEEN",1);
-  pMC->Gsatt("P016","SEEN",1);
-  pMC->Gsatt("P017","SEEN",1);
-  pMC->Gsatt("P018","SEEN",1);
-  pMC->Gsatt("P019","SEEN",1);
-  pMC->Gsatt("P020","SEEN",1);
-  pMC->Gsatt("P021","SEEN",1);
-  pMC->Gsatt("Q021","SEEN",1);
-  pMC->Gsatt("R021","SEEN",1);
-  pMC->Gsatt("P022","SEEN",1);
-  pMC->Gsatt("P023","SEEN",1);
-  pMC->Gsatt("D1  ","SEEN",1);
-  pMC->Gsatt("YD1 ","SEEN",1);
-  pMC->Gsatt("D2  ","SEEN",1);
-  pMC->Gsatt("YD2 ","SEEN",1);
-  pMC->Gsatt("MCBW","SEEN",1);
-  pMC->Gsatt("YMCB","SEEN",1);
-  pMC->Gsatt("MQXL","SEEN",1);
-  pMC->Gsatt("YMQL","SEEN",1);
-  pMC->Gsatt("MQX","SEEN",1);
-  pMC->Gsatt("YMQ","SEEN",1);
-  pMC->Gsatt("D1","SEEN",1);
-  pMC->Gsatt("YD1","SEEN",1);
-  pMC->Gsatt("D2","SEEN",1);
-  pMC->Gsatt("YD2","SEEN",1);
-  pMC->Gsatt("ZNEU","SEEN",0);
-  pMC->Gsatt("ZNFI","SEEN",0);
-  pMC->Gsatt("ZNGR","SEEN",0);
-  pMC->Gsatt("ZNTX","SEEN",0);
-  pMC->Gsatt("ZN1 ","COLO",2); 
-  pMC->Gsatt("ZN1 ","SEEN",1);
-  pMC->Gsatt("ZNSL","SEEN",0);
-  pMC->Gsatt("ZNST","SEEN",0);
-  pMC->Gsatt("ZPRO","SEEN",0);
-  pMC->Gsatt("ZPFI","SEEN",0);
-  pMC->Gsatt("ZPGR","SEEN",0);
-  pMC->Gsatt("ZPTX","SEEN",0);
-  pMC->Gsatt("ZP1 ","SEEN",1);
-  pMC->Gsatt("ZPSL","SEEN",0);
-  pMC->Gsatt("ZPST","SEEN",0);
-  
-  //
-  pMC->Gdopt("hide", "on");
-  pMC->Gdopt("shad", "on");
-  pMC->Gsatt("*", "fill", 7);
-  pMC->SetClipBox(".");
-  pMC->SetClipBox("*", 0, 100, -100, 100, 12000, 16000);
-  pMC->DefaultRange();
-  pMC->Gdraw("alic", 40, 30, 0, 488, 220, .07, .07);
-  pMC->Gdhead(1111, "Zero Degree Calorimeter Version 1");
-  pMC->Gdman(18, 4, "MAN");
+    AliDetector *ZDC  = gAlice->GetDetector("ZDC");
+    TClonesArray *ZDCdigits = ZDC->Digits();
+    
+    char tdname[20];
+    sprintf(tdname,"TreeD%d",fNEvBgr);
+    TTree *TD = (TTree*)gDirectory->Get(tdname);
+    //TTree *TD = gAlice->TreeD();
+    if(TD){
+      //printf("       TreeD found in gAlice object\n");
+      char brname[20];
+      sprintf(brname,"%s",ZDC->GetName());
+      TBranch *br = TD->GetBranch(brname);
+      if(br) br->SetAddress(&ZDCdigits);
+    }
+    else if(!TD) printf("      ERROR -> TreeD NOT found in gAlice object\n");
+    
+    Int_t nt = (Int_t) (TD->GetEntries());
+    //printf("\n               #entries in TreeD = %d\n",nt);
+    gAlice->ResetDigits();    
+    
+    AliZDCDigit *dig;
+    Int_t j, idig, ndigits, ZNraw=0, ZPraw=0, ZEMraw=0;
+    // ---      Summing raw ADCs for each detector to obtain total light
+    for(j=0; j<nt; j++){
+      TD->GetEvent(j);
+      ndigits = ZDCdigits->GetEntries();
+      //printf("\n Entry #%d, ndigits = %d",j,ndigits);
+      ZNraw=0;
+      ZPraw=0; 
+      ZEMraw=0;
+      //  ---  Loop over event digits
+      for(idig=0; idig<ndigits; idig++){
+         dig = (AliZDCDigit*) ZDCdigits->UncheckedAt(idig);
+         if(dig->GetSector(0) == 1)     ZNraw  += dig->GetADCValue();
+         else if(dig->GetSector(0) == 2) ZPraw  += dig->GetADCValue();
+         else if(dig->GetSector(0) == 3) ZEMraw += dig->GetADCValue();
+      } // Digits loop
+    } //  TreeD entries loop
+    printf("\n ---     ZNraw = %d, ZPraw = %d, ZEMraw = %d\n",ZNraw, ZPraw, ZEMraw);
+    
+  //  ---      Pedestal subtraction
+  Int_t ZNcorr, ZPcorr, ZEMcorr, MeanPed=50;
+  ZNcorr  = ZNraw  - 5*MeanPed;
+  ZPcorr  = ZPraw  - 5*MeanPed;
+  ZEMcorr = ZEMraw - 2*MeanPed;
+  if(ZNcorr<0)  ZNcorr=0;
+  if(ZPcorr<0)  ZPcorr=0;
+  if(ZEMcorr<0) ZEMcorr=0;
+ printf("\n    ZNcorr = %d, ZPcorr = %d, ZEMcorr = %d\n",ZNcorr,ZPcorr,ZEMcorr);
+  
+  //  ---      ADCchannel -> photoelectrons
+  // NB-> PM gain = 10^(5), ADC resolution = 6.4*10^(-7)
+  Float_t ZNphe, ZPphe, ZEMphe, ConvFactor = 0.064;
+  ZNphe  = ZNcorr/ConvFactor;
+  ZPphe  = ZPcorr/ConvFactor;
+  ZEMphe = ZEMcorr/ConvFactor;
+  printf("\n    ZNphe = %f, ZPphe = %f, ZEMphe = %f\n",ZNphe, ZPphe, ZEMphe);
+  
+  //  ---      Energy calibration
+  // Conversion factors for hadronic ZDCs goes from phe yield to TRUE incident 
+  //  energy (conversion from GeV to TeV is included); while for EM calos 
+  // conversion is from light yield to detected energy calculated by GEANT
+  // NB -> ZN and ZP conversion factors are constant since incident spectators
+  // have all the same energy, ZEM energy is obtained through a fit over the whole
+  // range of incident particle energies (obtained with full HIJING simulations) 
+  Float_t ZNenergy, ZPenergy, ZEMenergy, ZDCenergy;
+  Float_t ZNphexTeV=329., ZPphexTeV=369.;
+  ZNenergy  = ZNphe/ZNphexTeV;
+  ZPenergy  = ZPphe/ZPphexTeV;
+  ZDCenergy = ZNenergy+ZPenergy;
+  ZEMenergy = -4.81+0.3238*ZEMphe;
+  if(ZEMenergy<0) ZEMenergy=0;
+  printf("    ZNenergy = %f TeV, ZPenergy = %f TeV, ZDCenergy = %f GeV, "
+         "\n           ZEMenergy = %f TeV\n", ZNenergy, ZPenergy, 
+        ZDCenergy, ZEMenergy);
+  
+  if(ZDCenergy==0)
+    printf("\n\n       ###     ATTENZIONE!!! -> ev# %d: ZNenergy = %f TeV, ZPenergy = %f TeV, ZDCenergy = %f GeV, "
+         " ZEMenergy = %f TeV\n\n", fNEvBgr, ZNenergy, ZPenergy, ZDCenergy, ZEMenergy); 
+  
+  //  ---      Number of incident spectator nucleons
+  Int_t NDetSpecN, NDetSpecP;
+  NDetSpecN = (Int_t) (ZNenergy/2.760);
+  NDetSpecP = (Int_t) (ZPenergy/2.760);
+  printf("\n    NDetSpecN = %d, NDetSpecP = %d\n",NDetSpecN, NDetSpecP);
+  
+  //  ---      Number of generated spectator nucleons and impact parameter
+  // Fit results for neutrons (Nspectator n true vs. EZN)
+  TF1 *fZNCen = new TF1("fZNCen",
+      "(-2.116909+sqrt(2.116909*2.116909-4*(-0.00651)*(14.556798-x)))/(2*(-0.00651))",0.,158.5);
+  TF1 *fZNPer = new TF1("fZNPer",
+      "(-34.695134-sqrt(34.695134*34.695134-4*(-0.174780)*(-1562.283443-x)))/(2*(-0.174780))",0.,158.5);
+  // Fit results for protons (Nspectator p true vs. EZP)
+  TF1 *fZPCen = new TF1("fZPCen",
+      "(-1.3217+sqrt(1.3217*1.3217-4*(-0.007934)*(4.742873-x)))/(2*(-0.007934))",0.,58.91);
+  TF1 *fZPPer = new TF1("fZPPer",
+      "(-15.788267-sqrt(15.788267*15.788267-4*(-0.133359)*(-383.800673-x)))/(2*(-0.133359))",0.,58.91);
+  // Fit results for total number of spectators (Nspectators true vs. EZDC)
+  TF1 *fZDCCen = new TF1("fZDCCen",
+      "(-1.867335+sqrt(1.867335*1.867335-4*(-0.004119)*(19.100289-x)))/(2*(-0.004119))",0.,220.4);
+  TF1 *fZDCPer = new TF1("fZDCPer",
+      "(-22.429097-sqrt(22.429097*22.429097-4*(-0.072435)*(-1482.034526-x)))/(2*(-0.072435))",0.,220.4);
+  // Fit results for b (b vs. EZDC)
+  //TF1 *fbCen = new TF1("fbCen","0.611543+0.052231*x-0.000112*x*x+0.000000374*x*x*x",0.,222.);
+  //TF1 *fbPer = new TF1("fbPer","16.552010-0.023866*x-0.00001*x*x",0.,222.);
+  TF1 *fbCen = new TF1("fbCen","0.612769+0.051929*x-0.0001074*x*x+0.0000003724*x*x*x",0.,225.);
+  TF1 *fbPer = new TF1("fbPer","16.6131016-0.026053*x+0.000006893*x*x",0.,225.);
+  // Evaluating Nspectators and b from ZEM energy
+  TF1 *fZEMn  = new TF1("fZEMn","124.2-0.0566*x+0.000006014*x*x",0.,3500.);
+  TF1 *fZEMp  = new TF1("fZEMp","81.3-0.03834*x+0.000004359*x*x",0.,3500.);
+  TF1 *fZEMsp = new TF1("fZEMsp","205.6-0.09567*x+0.00001056*x*x",0.,3500.);
+  TF1 *fZEMb  = new TF1("fZEMb","15.8-0.02084*x+2.802e-5*x*x-2.007e-8*x*x*x+6.586e-12*x*x*x*x-8.042e-16*x*x*x*x*x",0.,3500.);
+  
+  Int_t NGenSpecN=0, NGenSpecP=0, NGenSpec=0;
+  Double_t ImpPar=0;
+  Float_t EZEMCut = 360.; // Cut value for Ezem (GeV)
+  if(ZEMenergy >= EZEMCut){
+    NGenSpecN = (Int_t) (fZNCen->Eval(ZNenergy));
+    NGenSpecP = (Int_t) (fZPCen->Eval(ZPenergy));
+    NGenSpec  = (Int_t) (fZDCCen->Eval(ZDCenergy));
+    ImpPar    = fbCen->Eval(ZDCenergy);
+    //printf("    fZNCen = %f, fZPCen = %f, fZDCCen = %f\n",fZNCen->Eval(ZNenergy),
+    //            fZPCen->Eval(ZPenergy),fZDCCen->Eval(ZDCenergy));
+  }
+  else if(ZEMenergy < EZEMCut){
+    NGenSpecN = (Int_t) (fZNPer->Eval(ZNenergy)); 
+    NGenSpecP = (Int_t) (fZPPer->Eval(ZPenergy));
+    NGenSpec  = (Int_t) (fZDCPer->Eval(ZDCenergy));
+    ImpPar    = fbPer->Eval(ZDCenergy);
+    //printf("    fZNPer = %f, fZPPer = %f, fZDCPer = %f\n",fZNPer->Eval(ZNenergy),
+    //            fZPPer->Eval(ZPenergy),fZDCPer->Eval(ZDCenergy));
+  }
+  if(ZNenergy>158.5)  NGenSpecN = (Int_t) (fZEMn->Eval(ZEMenergy));
+  if(ZPenergy>58.91)  NGenSpecP = (Int_t) (fZEMp->Eval(ZEMenergy));
+  if(ZDCenergy>220.4) NGenSpec  = (Int_t)(fZEMsp->Eval(ZEMenergy));
+  if(ZDCenergy>225.)  ImpPar    =          fZEMb->Eval(ZEMenergy);
+  /*if(ZNenergy>158.5)  NGenSpecN = -999;
+  if(ZPenergy>58.91)  NGenSpecP = -999;
+  if(ZDCenergy>220.4) NGenSpec  = -999;
+  if(ZDCenergy>225.)  ImpPar    = -999;*/
+  
+  if(NGenSpecN>125)    NGenSpecN=125;
+  else if(NGenSpecN<0) NGenSpecN=0;
+  if(NGenSpecP>82)     NGenSpecP=82;
+  else if(NGenSpecP<0) NGenSpecP=0;
+  if(NGenSpec>207)     NGenSpec=207;
+  else if(NGenSpec<0)  NGenSpec=0;
+  printf("    NRecSpecN = %d, NRecSpecP = %d, NRecSpec = %d\n",NGenSpecN,NGenSpecP,NGenSpec);
+  
+  //  ---      Number of participants
+  Int_t NPart, NPartTot;
+  NPart = 208-NGenSpecN-NGenSpecP;
+  NPartTot = 208-NGenSpec;
+  printf("     ###     NPart(ZP+ZN) = %d, NPart(ZDC) = %d, b = %f fm\n",NPart,NPartTot,ImpPar);
+  
+  //  ---     Writing RecPoints TCA
+  // Allocate the RecPoints TCA 
+  fRecPoints = new TClonesArray("AliZDCReco",1000);
+  AliZDCReco *reco = new AliZDCReco(ZNenergy,ZPenergy,ZDCenergy,ZEMenergy,
+             NDetSpecN,NDetSpecP,NGenSpecN,NGenSpecP,NGenSpec,NPartTot,ImpPar);
+  new((*fRecPoints)[fNRecPoints]) AliZDCReco(*reco);
+  //printf("   fNRecPoints = %d \n",fNRecPoints );
+  //fNRecPoints++;
+  //fRecPoints->Dump();
+  delete reco;
+  
+  // TreeR
+  TTree *treeR = gAlice->TreeR();
+  char tname[20];
+  sprintf(tname,"TreeR%d",fNEvBgr);
+  if(!treeR) printf("\n ERROR -> Can't find TreeR%d in background file\n",fNEvBgr);
+  // Branch address
+  char branchRname[20];
+  sprintf(branchRname,"%s",GetName());
+  if(fRecPoints){
+    TBranch *branchR = treeR->GetBranch(branchRname);
+    if(branchR) branchR->SetAddress(&fRecPoints);
+    else if(!branchR) MakeBranchInTreeR(treeR);
+  }
+  treeR->Fill();
+  treeR->Write(tname,TObject::kOverwrite);
+  treeR->Reset();
 }
 
 //_____________________________________________________________________________
-void AliZDCv1::CreateMaterials()
+void   AliZDC::SetMerger(AliZDCMerger* merger)
 {
-  //
-  // Create Materials for the Zero Degree Calorimeter
-  //
-  // Origin    : E. Scomparin 
-  
-  AliMC* pMC = AliMC::GetMC();
-  
-  Int_t *idtmed = gAlice->Idtmed();
-  
-  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(801, "ZW", 1, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(802, "ZBRASS", 2, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(803, "ZSIO2", 3, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(804, "ZLEAD", 4, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(805, "ZCOPP", 5, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(806, "ZTANT", 6, isvol_active, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(852, "ZIRON", 52, isvol, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(890, "ZVOID", 90, isvol, inofld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(892, "Air", 92, 0, inofld, fieldm, tmaxfd, stemax,deemax, epsil, stmin);
-  
-  fieldm = 45.;
-  //    AliMedium(891, "ZVOIM", 91, isvol, isxfld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  AliMedium(891, "ZVOIM", 91, isvol, isxfld, fieldm, tmaxfd, stemax, deemax, epsil, stmin);
-  
-  // Thresholds for showering in the ZDCs 
-  
-  i = 801;
-  pMC->Gstpar(idtmed[i-1], "CUTGAM", .01);
-  pMC->Gstpar(idtmed[i-1], "CUTELE", .01);
-  pMC->Gstpar(idtmed[i-1], "CUTNEU", .1);
-  pMC->Gstpar(idtmed[i-1], "CUTHAD", .1);
-  i = 802;
-  pMC->Gstpar(idtmed[i-1], "CUTGAM", .01);
-  pMC->Gstpar(idtmed[i-1], "CUTELE", .01);
-  pMC->Gstpar(idtmed[i-1], "CUTNEU", .1);
-  pMC->Gstpar(idtmed[i-1], "CUTHAD", .1);
-  
-  // Avoid too detailed showering along the beam line 
-  
-  i = 852;
-  pMC->Gstpar(idtmed[i-1], "CUTGAM", .1);
-  pMC->Gstpar(idtmed[i-1], "CUTELE", .1);
-  pMC->Gstpar(idtmed[i-1], "CUTNEU", 1.);
-  pMC->Gstpar(idtmed[i-1], "CUTHAD", 1.);
-  
-  // Avoid interaction in fibers (only energy loss allowed) 
-  i = 803;
-  pMC->Gstpar(idtmed[i-1], "DCAY", 0.);
-  pMC->Gstpar(idtmed[i-1], "MULS", 0.);
-  pMC->Gstpar(idtmed[i-1], "PFIS", 0.);
-  pMC->Gstpar(idtmed[i-1], "MUNU", 0.);
-  pMC->Gstpar(idtmed[i-1], "LOSS", 1.);
-  pMC->Gstpar(idtmed[i-1], "PHOT", 0.);
-  pMC->Gstpar(idtmed[i-1], "COMP", 0.);
-  pMC->Gstpar(idtmed[i-1], "PAIR", 0.);
-  pMC->Gstpar(idtmed[i-1], "BREM", 0.);
-  pMC->Gstpar(idtmed[i-1], "DRAY", 0.);
-  pMC->Gstpar(idtmed[i-1], "ANNI", 0.);
-  pMC->Gstpar(idtmed[i-1], "HADR", 0.);
+// Set pointer to merger 
+    fMerger = merger;
 }
 
-ClassImp(AliZDChit)
-  
 //_____________________________________________________________________________
-AliZDChit::AliZDChit(Int_t shunt, Int_t track, Int_t *vol, Float_t *hits):
-  AliHit(shunt, track)
+AliZDCMerger*  AliZDC::Merger()
 {
-  //
-  // 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];
+// Return pointer to merger
+    return fMerger;
 }
+