]> git.uio.no Git - u/mrichter/AliRoot.git/commitdiff
inor correction before clean up for MDC
authorpavlinov <pavlinov@f7af4fe6-9843-0410-8265-dc069ae4e863>
Thu, 19 Jan 2006 14:53:30 +0000 (14:53 +0000)
committerpavlinov <pavlinov@f7af4fe6-9843-0410-8265-dc069ae4e863>
Thu, 19 Jan 2006 14:53:30 +0000 (14:53 +0000)
EMCAL/AliEMCALHitv1.cxx [new file with mode: 0644]
EMCAL/AliEMCALHitv1.h [new file with mode: 0644]
EMCAL/AliEMCALv3.cxx [new file with mode: 0644]
EMCAL/AliEMCALv3.h [new file with mode: 0644]

diff --git a/EMCAL/AliEMCALHitv1.cxx b/EMCAL/AliEMCALHitv1.cxx
new file mode 100644 (file)
index 0000000..14d5038
--- /dev/null
@@ -0,0 +1,130 @@
+ /**************************************************************************
+ * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ *                                                                        *
+ * Author: The ALICE Off-line Project.                                    *
+ * Contributors are mentioned in the code where appropriate.              *
+ *                                                                        *
+ * Permission to use, copy, modify and distribute this software and its   *
+ * documentation strictly for non-commercial purposes is hereby granted   *
+ * without fee, provided that the above copyright notice appears in all   *
+ * copies and that both the copyright notice and this permission notice   *
+ * appear in the supporting documentation. The authors make no claims     *
+ * about the suitability of this software for any purpose. It is          *
+ * provided "as is" without express or implied warranty.                  *
+ **************************************************************************/
+
+/* $Id: */
+
+//_________________________________________________________________________
+//  Hits class for EMCAL    
+//  A hit in EMCAL is the usuall hi with full information about xlocal, ylocal, zlocal 
+//*-- Author: Aleksei Pavlinov(WSU); Nov 25, 05
+
+#include <Riostream.h>
+
+// --- AliRoot header files ---
+#include "AliEMCALHitv1.h"
+
+ClassImp(AliEMCALHitv1)
+
+//______________________________________________________________________
+AliEMCALHitv1::AliEMCALHitv1(){
+    // Default ctor
+   
+    fId      = 0;
+    fELOS    = 0.0;
+    fTime    = 0.0;
+    fPrimary = 0;
+    fTrack   = 0;
+    fX       = 0.0;
+    fY       = 0.0;
+    fZ       = 0.0;
+    fPx      = 0.0;
+    fPy      = 0.0;
+    fPz      = 0.0;
+    fPe      = 0.0;
+    fIparent = 0;
+    fIenergy = 0.0;
+}
+//______________________________________________________________________
+AliEMCALHitv1::AliEMCALHitv1(const AliEMCALHitv1 & hit) : AliHit(hit){
+    // copy ctor
+   
+    fId      = hit.fId ; 
+    fELOS    = hit.fELOS ;
+    fPrimary = hit.fPrimary ; 
+    fTrack   = hit.fTrack ; 
+    fX       = hit.fX;
+    fY       = hit.fY;
+    fZ       = hit.fZ;
+    fPx      = hit.fPx;
+    fPy      = hit.fPy;
+    fPz      = hit.fPz;
+    fPe      = hit.fPe;
+    fIparent = hit.fIparent;
+    fIenergy = hit.fIenergy;
+    fTime    = hit.fTime  ;
+}
+//______________________________________________________________________
+AliEMCALHitv1::AliEMCALHitv1(Int_t shunt, Int_t primary, Int_t track,Int_t iparent, Float_t ienergy, Int_t id,
+                        Float_t *hits,Float_t *p):AliHit(shunt, track){
+    //
+    // Create an EMCAL  hit object
+    //
+    fX          = hits[0];
+    fY          = hits[1];
+    fZ          = hits[2];
+    fTime       = hits[3] ;
+    fId         = id;
+    fELOS       = hits[4];
+    fPrimary    = primary;
+    fPx         = p[0];
+    fPy         = p[1];
+    fPz         = p[2];
+    fPe         = p[3];
+    fIparent    = iparent;
+    fIenergy    = ienergy;
+}
+
+//______________________________________________________________________
+Bool_t AliEMCALHitv1::operator==(AliEMCALHitv1 const &rValue) const{ 
+  // no identical hits !!
+    Bool_t rv = kFALSE;
+
+    if ( (fId == rValue.GetId()));
+    //    if ( (fId == rValue.GetId()) && ( fIparent == rValue.GetIparent()))
+    // rv = kTRUE;
+
+    return rv;
+}
+//______________________________________________________________________
+AliEMCALHitv1 AliEMCALHitv1::operator+(const AliEMCALHitv1 &rValue){
+    // Add the energy of the hit
+
+    fELOS += rValue.GetEnergy() ;
+    if(rValue.GetTime() < fTime)
+      fTime = rValue.GetTime() ;
+    return *this;
+
+}
+//______________________________________________________________________
+ostream& operator << (ostream& out,AliEMCALHitv1& hit){
+    // Print out Id and energy
+
+    out << "AliEMCALHitv1:";
+    out << "id=" <<  hit.GetId();
+    out << ", Eloss=" <<  hit.GetEnergy();
+    out << ", Time=" << hit.GetTime();
+    out << "GeV , Track no.=" << hit.GetPrimary();
+    out << ", (xyz)=(" << hit.X()<< ","<< hit.Y()<< ","<<hit.Z()<<") cm <- local";
+    out << ", fTrack=" << hit.GetTrack();
+    out << ", P=(" << hit.GetPx() << "," << hit.GetPy() << "," << hit.GetPz()
+                  << "," <<hit.GetPe() << ") GeV"  ;
+    out << ", Enterring particle ID" << hit.GetIparent();
+    out << ", Enterring particle initial energy = " << hit.GetIenergy() << " GeV" ;
+    out << endl;
+
+    return out;
+}
diff --git a/EMCAL/AliEMCALHitv1.h b/EMCAL/AliEMCALHitv1.h
new file mode 100644 (file)
index 0000000..ba66c82
--- /dev/null
@@ -0,0 +1,70 @@
+#ifndef ALIEMCALHITV1_H
+#define ALIEMCALHITV1_H
+/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice                               */
+
+/* $Id: */
+
+//_________________________________________________________________________
+//  Hits class for EMCAL    
+//  A hit in EMCAL is the usuall hi with full information about xlocal, ylocal, zlocal 
+//               
+//*-- Author: Aleksei Pavlinov(WSU) 
+// Based on AliPHOSHit                                * See cxx source for full Copyright notice                               */
+
+
+// --- AliRoot header files ---
+#include "AliHit.h"
+
+
+class AliEMCALHitv1 : public AliHit {
+    
+  friend ostream& operator << (ostream&,AliEMCALHitv1&);
+public:
+  AliEMCALHitv1(); // default ctor
+  AliEMCALHitv1(const AliEMCALHitv1 & hit);
+  AliEMCALHitv1(Int_t shunt, Int_t primary, Int_t tracknumber, Int_t iparent, Float_t ienergy, Int_t id, Float_t *hits,Float_t *p);
+  virtual ~AliEMCALHitv1(void) {}// dtor
+  //returns the energy loss for this hit
+  Float_t GetEnergy(void) const{return fELOS;}
+  // return the identificator of this his
+  Int_t   GetId(void) const { return fId;}
+  // returns the primary particle id at the origine of this hit 
+  Int_t   GetIparent(void) const{return fIparent;}
+  Float_t GetIenergy(void) const{return fIenergy;}
+  Int_t   GetPrimary(void) const{return fPrimary;}
+  // returns the energy/momentum LorentzVector of the enetering particle.
+  Float_t GetTime(void)     const {
+    // returns the time of the first energy deposition
+    return fTime ;}
+
+  Float_t GetPx(void) const{return fPx;}
+  Float_t GetPy(void) const{return fPy;}
+  Float_t GetPz(void) const{return fPz;}
+  Float_t GetPe(void) const{return fPe;}
+
+  void   SetIparent(Int_t i_parent) {fIparent=i_parent;}
+  void   SetPrimary(Int_t primary)  {fPrimary=primary;}
+
+  Bool_t operator == (AliEMCALHitv1 const &rValue) const;
+  AliEMCALHitv1 operator + (const AliEMCALHitv1& rValue);
+  
+ private:
+
+  Int_t          fId;        // Absolute Id number EMCAL segment
+  Float_t        fELOS;      // Energy deposited
+  Int_t          fPrimary;   // Primary particles at the origin of the hit
+  Float_t        fPx;      // Primary particle entrance momentum/energy
+  Float_t        fPy;      // Primary particle entrance momentum/energy
+  Float_t        fPz;      // Primary particle entrance momentum/energy
+  Float_t        fPe;      // Primary particle entrance momentum/energy
+  Int_t          fIparent;   // Parent particle that entered emcal
+  Float_t        fIenergy;   // Initial energy of parent particle that enterred the emcal
+  Float_t        fTime ;      // Time of the energy deposition
+  
+  ClassDef(AliEMCALHitv1,0)  // Hit for EMCAL
+    
+};
+
+#endif // ALIEMCALHITV1_H
diff --git a/EMCAL/AliEMCALv3.cxx b/EMCAL/AliEMCALv3.cxx
new file mode 100644 (file)
index 0000000..a9f4a61
--- /dev/null
@@ -0,0 +1,302 @@
+/**************************************************************************
+ * Copyright(c) 1998-2004, ALICE Experiment at CERN, All rights reserved. *
+ *                                                                        *
+ * Author: The ALICE Off-line Project.                                    *
+ * Contributors are mentioned in the code where appropriate.              *
+ *                                                                        *
+ * Permission to use, copy, modify and distribute this software and its   *
+ * documentation strictly for non-commercial purposes is hereby granted   *
+ * without fee, provided that the above copyright notice appears in all   *
+ * copies and that both the copyright notice and this permission notice   *
+ * appear in the supporting documentation. The authors make no claims     *
+ * about the suitability of this software for any purpose. It is          *
+ * provided "as is" without express or implied warranty.                  *
+ **************************************************************************/
+
+/* $Id$ */
+
+//_________________________________________________________________________
+//*-- Implementation version v2 of EMCAL Manager class; SHASHLYK version
+//*-- An object of this class does not produce digits
+//*-- It is the one to use if you do want to produce outputs in TREEH 
+//*--                  
+//*-- Author : Aleksei Pavlinov (WSU)
+
+// This Class not stores information on all particles prior to EMCAL entry - in order to facilitate analysis.
+// This is done by setting fIShunt =2, and flagging all parents of particles entering the EMCAL.
+
+// --- ROOT system ---
+#include "AliEMCALv3.h"
+#include "AliEMCALHitv1.h"
+
+#include "TParticle.h"
+#include "TVirtualMC.h"
+#include "TBrowser.h"
+#include "TH1.h"
+#include "TH2.h"
+
+// --- Standard library ---
+
+// --- AliRoot header files ---
+#include "AliEMCALGeometry.h"
+#include "AliRun.h"
+#include "AliHeader.h"
+#include "AliMC.h"
+#include "AliPoints.h"
+#include "AliEMCALGetter.h"
+// for TRD1,2 case
+
+ClassImp(AliEMCALv3)
+
+  //extern "C" void gdaxis_(float &x0, float &y0, float &z0, float &axsiz);
+
+
+//______________________________________________________________________
+AliEMCALv3::AliEMCALv3():AliEMCALv1(){
+  // ctor
+
+}
+
+//______________________________________________________________________
+AliEMCALv3::AliEMCALv3(const char *name, const char *title): AliEMCALv1(name,title) {
+    // Standard Creator.
+
+    fHits= new TClonesArray("AliEMCALHitv1",2000);
+    gAlice->GetMCApp()->AddHitList(fHits);
+
+    fNhits    = 0;
+    fIshunt   = 2; // All hits are associated with particles entering the calorimeter
+    fTimeCut  = 30e-09;
+
+    fGeometry = GetGeometry(); 
+    fHDe = fHNhits = 0;
+    //    if (gDebug>0){
+    if (1){
+      TH1::AddDirectory(0);
+      fHDe = new TH1F("fHDe","De in EMCAL", 1000, 0., 1.);
+      fHNhits = new TH1F("fHNhits","#hits in EMCAL", 1001, -0.5, 1000.5);
+      int nbin = 77*2;
+      fHDeDz = new TH1F("fHDeDz","Longitudinal shower profile", 6*nbin, 0.0, 0.16*nbin);
+      
+      fHistograms->Add(fHDe);
+      fHistograms->Add(fHNhits);
+      fHistograms->Add(fHDeDz);
+      TH1::AddDirectory(1);
+    }
+}
+
+//______________________________________________________________________
+AliEMCALv3::~AliEMCALv3(){
+    // dtor
+
+    if ( fHits) {
+       fHits->Delete();
+       delete fHits;
+       fHits = 0;
+    }
+}
+
+//______________________________________________________________________
+void AliEMCALv3::AddHit(Int_t shunt, Int_t primary, Int_t tracknumber, Int_t iparent, Float_t ienergy, 
+                       Int_t id, Float_t * hits,Float_t * p){
+    // Add a hit to the hit list.
+    // An EMCAL hit is the sum of all hits in a tower section
+    //   originating from the same entering particle 
+    static Int_t hitCounter;
+    static AliEMCALHitv1 *newHit, *curHit;
+    static Bool_t deja;
+
+    deja = kFALSE;
+
+    newHit = new AliEMCALHitv1(shunt, primary, tracknumber, iparent, ienergy, id, hits, p);
+    for ( hitCounter = fNhits-1; hitCounter >= 0 && !deja; hitCounter-- ) {
+       curHit = (AliEMCALHitv1*) (*fHits)[hitCounter];
+       // We add hits with the same tracknumber, while GEANT treats
+       // primaries succesively
+       if(curHit->GetPrimary() != primary) 
+         break;
+       if( *curHit == *newHit ) {
+           *curHit = *curHit + *newHit;
+           deja = kTRUE;
+           //            break; // 30-aug-04 by PAI 
+       } // end if
+    } // end for hitCounter
+    
+    if ( !deja ) {
+       new((*fHits)[fNhits]) AliEMCALHitv1(*newHit);
+       fNhits++;
+    }
+    //    printf(" fNhits %i \n", fNhits); 
+    delete newHit;
+}
+//______________________________________________________________________
+void AliEMCALv3::StepManager(void){
+  // Accumulates hits as long as the track stays in a tower
+
+  // position wrt MRS and energy deposited
+  static Float_t        xyzte[5]={0.,0.,0.,0.,0.};// position wrt MRS, time and energy deposited
+  static Float_t        pmom[4]={0.,0.,0.,0.};
+  static TLorentzVector pos; // Lorentz vector of the track current position.
+  static TLorentzVector mom; // Lorentz vector of the track current momentum.
+  static Float_t ienergy = 0;
+  static TString curVolName;
+  static int supModuleNumber, moduleNumber, yNumber, xNumber, absid;
+  static int keyGeom=0;
+  static char *vn = "SX"; // 15-mar-05
+  static int nSMOP[7]={1,3,5,7,9,11}; // 30-mar-05
+  static int nSMON[7]={2,4,6,8,10,12};
+  static Float_t depositedEnergy=0.0; 
+
+  if(keyGeom == 0) {
+    keyGeom = 2;
+    if(gMC->VolId("PBMO")==0 || gMC->VolId("WSUC")==1) {
+      vn      = "SCMX";   // old TRD2(TRD1) or WSUC
+      keyGeom = 1;
+    }    
+    printf("AliEMCALv3::StepManager():  keyGeom %i : Sensetive volume %s \n", 
+    keyGeom, vn); 
+    if(gMC->VolId("WSUC")==1) printf(" WSUC - cosmic ray stand geometry \n");
+  }
+  Int_t tracknumber =  gAlice->GetMCApp()->GetCurrentTrackNumber();
+
+  curVolName = gMC->CurrentVolName();
+  if(curVolName.Contains(vn)) { // We are in a scintillator layer
+    //    printf(" keyGeom %i : Sensetive volume %s (%s) \n", keyGeom, curVolName.Data(), vn); 
+    
+    if( ((depositedEnergy = gMC->Edep()) > 0.)  && (gMC->TrackTime() < fTimeCut)){// Track is inside a scintillator and deposits some energy
+      //       Info("StepManager "," entry %i DE %f",++ientry, depositedEnergy); // for testing
+       if (fCurPrimary==-1) 
+       fCurPrimary=gAlice->GetMCApp()->GetPrimary(tracknumber);
+
+      if (fCurParent==-1 || tracknumber != fCurTrack) {
+       // Check parentage
+       Int_t parent=tracknumber;
+       if (fCurParent != -1) {
+         while (parent != fCurParent && parent != -1) {
+           TParticle *part=gAlice->GetMCApp()->Particle(parent);
+           parent=part->GetFirstMother();
+         }
+       }
+       if (fCurParent==-1 || parent==-1) {
+         Int_t parent=tracknumber;
+         TParticle *part=gAlice->GetMCApp()->Particle(parent);
+         while (parent != -1 && fGeometry->IsInEMCAL(part->Vx(),part->Vy(),part->Vz())) {
+           parent=part->GetFirstMother();
+           if (parent!=-1) 
+             part=gAlice->GetMCApp()->Particle(parent);
+         } 
+         fCurParent=parent;
+         if (fCurParent==-1)
+           Error("StepManager","Cannot find parent");
+         else {
+           TParticle *part=gAlice->GetMCApp()->Particle(fCurParent);
+           ienergy = part->Energy(); 
+         }
+         while (parent != -1) {
+           part=gAlice->GetMCApp()->Particle(parent);
+           part->SetBit(kKeepBit);
+           parent=part->GetFirstMother();
+         }
+       }
+       fCurTrack=tracknumber;
+      }    
+      gMC->TrackPosition(pos);
+      xyzte[0] = pos[0];
+      xyzte[1] = pos[1];
+      xyzte[2] = pos[2];
+      xyzte[3] = gMC->TrackTime() ;       
+      
+      gMC->TrackMomentum(mom);
+      pmom[0] = mom[0];
+      pmom[1] = mom[1];
+      pmom[2] = mom[2];
+      pmom[3] = mom[3];
+      
+      //      if(ientry%200 > 0) return; // testing
+      supModuleNumber = moduleNumber = yNumber = xNumber = absid = 0;
+      if(keyGeom >= 1) { // old style
+        gMC->CurrentVolOffID(4, supModuleNumber);
+        gMC->CurrentVolOffID(3, moduleNumber);
+        gMC->CurrentVolOffID(1, yNumber);
+        gMC->CurrentVolOffID(0, xNumber); // really x number now
+        if(strcmp(gMC->CurrentVolOffName(4),"SM10")==0) supModuleNumber += 10; // 13-oct-05
+      } else {
+        gMC->CurrentVolOffID(5, supModuleNumber);
+        gMC->CurrentVolOffID(4, moduleNumber);
+        gMC->CurrentVolOffID(1, yNumber);
+        gMC->CurrentVolOffID(0, xNumber);
+        if     (strcmp(gMC->CurrentVolOffName(5),"SMOP")==0) supModuleNumber = nSMOP[supModuleNumber-1];
+        else if(strcmp(gMC->CurrentVolOffName(5),"SMON")==0) supModuleNumber = nSMON[supModuleNumber-1];
+        else   assert(0); // something wrong
+      }
+      absid = fGeometry->GetAbsCellId(supModuleNumber, moduleNumber, yNumber, xNumber);
+    
+      if (absid == -1) Fatal("StepManager()", "Wrong id ") ;
+
+      Float_t lightYield =  depositedEnergy ;
+      // Apply Birk's law (copied from G3BIRK)
+
+      if (gMC->TrackCharge()!=0) { // Check
+         Float_t BirkC1_mod = 0;
+       if (fBirkC0==1){ // Apply correction for higher charge states
+         if (TMath::Abs(gMC->TrackCharge())>=2) BirkC1_mod=fBirkC1*7.2/12.6;
+         else                                    BirkC1_mod=fBirkC1;
+       }
+
+       Float_t dedxcm;
+       if (gMC->TrackStep()>0)  dedxcm=1000.*gMC->Edep()/gMC->TrackStep();
+       else                     dedxcm=0;
+       lightYield=lightYield/(1.+BirkC1_mod*dedxcm+fBirkC2*dedxcm*dedxcm);
+      } 
+
+      xyzte[4] = lightYield; // 15-dec-04
+      Float_t xd[5]; // see Gmtod
+      gMC->Gmtod(xyzte, xd, 1);
+      xd[3] = xyzte[3];
+      xd[4] = xyzte[4];
+      //      printf(" x %7.2f y %7.2f z %7.2f de %f\n", xd[0], xd[1], xd[2], xd[4]);
+        
+      if (gDebug == -2) 
+      printf("#sm %2i #m %3i #x %1i #z %1i -> absid %i : xyzte[4] = %f\n",
+      supModuleNumber,moduleNumber,yNumber,xNumber,absid, xd[4]);
+
+      AddHit(fIshunt, fCurPrimary,tracknumber, fCurParent, ienergy, absid,  xd, pmom);
+    } // there is deposited energy
+  }
+}
+
+void AliEMCALv3::FinishEvent()
+{ // 26-may-05
+  static double de=0.;
+  fHNhits->Fill(double(fHits->GetEntries()));
+  de = GetDepositEnergy(0);
+  if(fHDe) fHDe->Fill(de);
+}
+
+Double_t AliEMCALv3::GetDepositEnergy(int print)
+{ // 23-mar-05 - for testing
+  //  cout<<"AliEMCALv3::GetDepositEnergy() : fHits "<<fHits<<endl; 
+  if(fHits == 0) return 0.;
+  static AliEMCALHitv1  *hit=0;
+  static Double_t de=0., deHit=0., zhl=0.0, zShift = 0.16*77;
+  for(int ih=0; ih<fHits->GetEntries(); ih++) {
+    hit = (AliEMCALHitv1*)fHits->UncheckedAt(ih);
+    deHit  = (double)hit->GetEnergy();
+    zhl    = (double)hit->Z() + zShift;
+    if(zhl>2.*zShift) zhl = 2*zShift - 0.002;
+    de    += deHit;
+    if(fHDeDz) fHDeDz->Fill(zhl, deHit);
+  }
+  if(print>0) {
+    printf(" #hits %i de %f \n", fHits->GetEntries(), de);
+    if(print>1) {
+      printf(" #primary particles %i\n", gAlice->GetHeader()->GetNprimary()); 
+    }
+  }
+  return de;
+}
+
+void AliEMCALv3::Browse(TBrowser* b)
+{
+  TObject::Browse(b);
+}
diff --git a/EMCAL/AliEMCALv3.h b/EMCAL/AliEMCALv3.h
new file mode 100644 (file)
index 0000000..eac1fc9
--- /dev/null
@@ -0,0 +1,60 @@
+#ifndef ALIEMCALV3_H
+#define ALIEMCALV3_H
+/* Copyright(c) 1998-2004, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice                      
+         */
+/* $Id$ */
+
+//_________________________________________________________________________
+// Implementation version v3 of EMCAL Manager class for Shish-Kebab case 
+// Save all hits inside of Sc - Nov 25, 05
+//*--                  
+//*-- Author:  Aleksei Pavlinov
+
+class TClonesArray;
+class TLorentzVector;
+class TFile;
+class TH1F;
+
+class AliEMCALGeometry;
+
+// --- AliRoot header files ---
+#include "AliEMCALv1.h"
+
+class AliEMCALv3 : public AliEMCALv1 {
+  
+public:
+
+  AliEMCALv3(void) ; 
+  AliEMCALv3(const char *name, const char *title="") ;
+  // cpy ctor: no implementation yet
+  // requested by the Coding Convention
+  AliEMCALv3(const AliEMCALv3 & emcal):AliEMCALv1(emcal) {
+    Fatal("cpy ctor", "not implemented") ;  }
+  virtual ~AliEMCALv3(void) ;
+  virtual void  AddHit( Int_t shunt, Int_t primary, Int_t track, Int_t iparent, Float_t ienergy,
+                       Int_t id, Float_t *hits, Float_t *p);
+
+  virtual void StepManager(void) ;
+  virtual void FinishEvent();
+
+  // Gives the version number 
+  virtual Int_t  IsVersion(void) const {return 3;}
+  virtual const TString Version(void)const {return TString("v3");}
+  AliEMCALv3 & operator = (const AliEMCALv3 & /*rvalue*/){
+    Fatal("operator =", "not implemented") ;  
+    return *this;}
+
+  virtual Double_t GetDepositEnergy(int print=1); // *MENU*
+  virtual void Browse(TBrowser* b);
+
+  AliEMCALGeometry* fGeometry; //!
+  TH1F*             fHDe;      //!
+  TH1F*             fHNhits;   //!
+  TH1F*             fHDeDz;     //!
+
+  ClassDef(AliEMCALv3,0)    //Implementation of EMCAL manager class to produce hits in a Shish-Kebab
+    
+};
+
+#endif // AliEMCALV3_H