]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - FMD/AliFMDReconstructor.cxx
First V0 MC Analysis from H.Ricaud
[u/mrichter/AliRoot.git] / FMD / AliFMDReconstructor.cxx
index 085c91a37e881db584de8724232cf6c9b0e0555b..acf44e3f102004b15ce631615a2dda39ac6af5f9 100644 (file)
  * about the suitability of this software for any purpose. It is          *
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
-
-//_________________________________________________________________________
-// This is a class that constructs ReconstParticles (reconstructed particles) 
-// out of Digits
-// 
+/* $Id$ */
+/** @file    AliFMDReconstructor.cxx
+    @author  Christian Holm Christensen <cholm@nbi.dk>
+    @date    Mon Mar 27 12:47:09 2006
+    @brief   FMD reconstruction 
+*/
+//____________________________________________________________________
+//
+// This is a class that constructs AliFMDRecPoint objects from of Digits
+// This class reads either digits from a TClonesArray or raw data from 
+// a DDL file (or similar), and stores the read ADC counts in an
+// internal cache (fAdcs).   The rec-points are made via the naiive
+// method. 
+//
 //-- Authors: Evgeny Karpechev(INR) and Alla Maevsksia
-//////////////////////////////////////////////////////////////////////////////
-
-// --- ROOT system ---
-#include "TTask.h"
-#include "TTree.h"
-#include "TSystem.h"
-#include "TFile.h"
-#include "TROOT.h"
-#include "TFolder.h"
-#include "TH2F.h"
-
-// --- Standard library ---
-#include <stdlib.h>
-#include <Riostream.h>
-
-// --- AliRoot header files ---
-
-#include "AliRunLoader.h"
-#include "AliLoader.h"
-
-#include "AliFMDdigit.h"
-#include "AliFMDhit.h"
-#include "AliFMDReconstParticles.h"
-#include "AliFMD.h"
-#include "AliFMDv1.h"
-#include "AliFMDReconstructor.h"
-#include "AliRun.h"
-#include "AliConfig.h"
-#include "AliHeader.h"
-#include "AliGenEventHeader.h"
+//  Latest changes by Christian Holm Christensen <cholm@nbi.dk>
+//
+//
+//____________________________________________________________________
+
+// #include <AliLog.h>                        // ALILOG_H
+// #include <AliRun.h>                        // ALIRUN_H
+#include "AliFMDDebug.h"
+#include "AliFMDGeometry.h"                // ALIFMDGEOMETRY_H
+#include "AliFMDParameters.h"              // ALIFMDPARAMETERS_H
+#include "AliFMDDigit.h"                   // ALIFMDDIGIT_H
+#include "AliFMDReconstructor.h"           // ALIFMDRECONSTRUCTOR_H
+#include "AliFMDRawReader.h"               // ALIFMDRAWREADER_H
+#include "AliFMDRecPoint.h"               // ALIFMDMULTNAIIVE_H
+#include "AliESDEvent.h"                  // ALIESDEVENT_H
+#include "AliESDVertex.h"                 // ALIESDVERTEX_H
+#include <AliESDFMD.h>                    // ALIESDFMD_H
+#include <TMath.h>
+#include <TH1.h>
+#include <TH2.h>
+#include <TFile.h>
+class AliRawReader;
 
+//____________________________________________________________________
 ClassImp(AliFMDReconstructor)
+#if 0
+  ; // This is here to keep Emacs for indenting the next line
+#endif
 
-        
-//____________________________________________________________________________
+//____________________________________________________________________
+AliFMDReconstructor::AliFMDReconstructor() 
+  : AliReconstructor(),
+    fMult(0x0), 
+    fNMult(0),
+    fTreeR(0x0),
+    fCurrentVertex(0),
+    fESDObj(0x0),
+    fNoiseFactor(0),
+    fAngleCorrect(kTRUE),
+    fVertexType(kNoVertex),
+    fESD(0x0),
+    fDiagnostics(kFALSE),
+    fDiagStep1(0), 
+    fDiagStep2(0),
+    fDiagStep3(0),
+    fDiagStep4(0),
+    fDiagAll(0)
+{
+  // Make a new FMD reconstructor object - default CTOR.  
+  SetNoiseFactor();
+  SetAngleCorrect();
+}
+  
 
-void AliFMDReconstructor::Reconstruct(AliRunLoader* runLoader) const
-{ 
- //Collects all digits in the same active volume into number of particles
-  /*
-    Reconstruct number of particles 
-    in given group of pads for given FMDvolume
-    determine by numberOfVolume , 
-    numberOfMinSector,numberOfMaxSector,
-    numberOfMinRing, numberOgMaxRing
-    Reconstructor method choose dependence on number of empty pads  
-  */
+//____________________________________________________________________
+AliFMDReconstructor::AliFMDReconstructor(const AliFMDReconstructor& other) 
+  : AliReconstructor(), 
+    fMult(other.fMult),
+    fNMult(other.fNMult),
+    fTreeR(other.fTreeR),
+    fCurrentVertex(other.fCurrentVertex),
+    fESDObj(other.fESDObj),
+    fNoiseFactor(other.fNoiseFactor),
+    fAngleCorrect(other.fAngleCorrect),
+    fVertexType(other.fVertexType),
+    fESD(other.fESD),
+    fDiagnostics(other.fDiagnostics),
+    fDiagStep1(other.fDiagStep1), 
+    fDiagStep2(other.fDiagStep2),
+    fDiagStep3(other.fDiagStep3),
+    fDiagStep4(other.fDiagStep4),
+    fDiagAll(other.fDiagAll) 
+{
+  // Copy constructor 
+}
+  
 
+//____________________________________________________________________
+AliFMDReconstructor&
+AliFMDReconstructor::operator=(const AliFMDReconstructor& other) 
+{
+  // Assignment operator
+  fMult          = other.fMult;
+  fNMult         = other.fNMult;
+  fTreeR         = other.fTreeR;
+  fCurrentVertex = other.fCurrentVertex;
+  fESDObj        = other.fESDObj;
+  fNoiseFactor   = other.fNoiseFactor;
+  fAngleCorrect  = other.fAngleCorrect;
+  fVertexType    = other.fVertexType;
+  fESD           = other.fESD;
+  fDiagnostics   = other.fDiagnostics;
+  fDiagStep1     = other.fDiagStep1;
+  fDiagStep2     = other.fDiagStep2;
+  fDiagStep3     = other.fDiagStep3;
+  fDiagStep4     = other.fDiagStep4;
+  fDiagAll       = other.fDiagAll;
+  return *this;
+}
 
-#ifdef DEBUG
-  Info("Exec ","Start");
-#endif
+//____________________________________________________________________
+AliFMDReconstructor::~AliFMDReconstructor() 
+{
+  // Destructor 
+  if (fMult)   fMult->Delete();
+  if (fMult)   delete fMult;
+  if (fESDObj) delete fESDObj;
+}
 
-  Int_t const knumVolumes=5;
-  Int_t padADC;
-  Float_t eta, etain,etaout,rad,theta;
-  Int_t ivol, iSector, iRing;
-  Float_t rin[5]={4.2,15.4,4.2,15.4,4.2};
-  Float_t rout[5]={17.4,28.4,17.4,28.4,17.4};
-  Float_t z[5]={-62.8, -75.2, 83.4, 75.2, 340.};
-  Int_t numberOfRings[5]={512,256,512,256,512};
-  Int_t numberOfSectors[5]=  {20,40,20,40,20};
-  Int_t numberOfEtaIntervals[5];
-  // number of ring for boundary 0.1 eta
+//____________________________________________________________________
+void 
+AliFMDReconstructor::Init() 
+{
+  // Initialize the reconstructor 
 
+  // Initialize the geometry 
+  AliFMDGeometry* geom = AliFMDGeometry::Instance();
+  geom->Init();
+  geom->InitTransformations();
+
+  // Initialize the parameters
+  AliFMDParameters* param = AliFMDParameters::Instance();
+  param->Init();
   
-  if (runLoader == 0x0)
-   {
-    Error("Exec","Run Loader loader is NULL - Session not opened");
-    return;
-   }
-
-  AliLoader* plFMD = runLoader->GetLoader("FMDLoader");
-  if (plFMD == 0x0)
-   {
-     Fatal("AliFMDReconstructor","Can not find FMD (loader) in specified event");
-     return;//never reached
-   }
-   
-  if (!runLoader->GetAliRun()) runLoader->LoadgAlice();
-  if (!runLoader->TreeE()) runLoader->LoadHeader();
-
-  TDirectory* cwd = gDirectory;
-  gDirectory = 0x0;
-  Text_t buf1[20];
-  TH2F* hTotal[10];
-  for (Int_t j=1; j<=5; j++){
-    sprintf(buf1,"hTotal%d",j);
-    
-    hTotal[j] = new TH2F(buf1," Number of primary particles ",
-                        numberOfSectors[j-1],1,numberOfSectors[j-1],
-                        numberOfRings[j-1],1,numberOfRings[j-1]);
-  }   
-  gDirectory = cwd;
-  plFMD->LoadRecPoints("RECREATE");
-  Int_t retval=0;     
-  Int_t nevents=Int_t (runLoader->TreeE()->GetEntries()); 
-#ifdef DEBUG
-  cout<<" nevents "<<nevents<<endl;
-#endif
-   for(Int_t ievent=0;ievent<nevents;ievent++)
-    { 
-#ifdef DEBUG
-      cout<<" *** event "<<ievent<<endl; 
+  // Current vertex position
+  fCurrentVertex = 0;
+  // Create array of reconstructed strip multiplicities 
+  fMult = new TClonesArray("AliFMDRecPoint", 51200);
+  // Create ESD output object 
+  fESDObj = new AliESDFMD;
+  
+  // Check if we need diagnostics histograms 
+  if (!fDiagnostics) return;
+  fDiagStep1   = new TH2I("diagStep1", "Read ADC vs. Noise surpressed ADC",
+                       1024, -.5, 1023.5, 1024, -.5, 1023.5);
+  fDiagStep1->SetDirectory(0);
+  fDiagStep1->GetXaxis()->SetTitle("ADC (read)");
+  fDiagStep1->GetYaxis()->SetTitle(Form("ADC (noise surpressed %4.f)", 
+                                       fNoiseFactor));
+  fDiagStep2  = new TH2F("diagStep2",  "ADC vs Edep deduced",
+                       1024, -.5, 1023.5, 100, 0, 2);
+  fDiagStep2->SetDirectory(0);
+  fDiagStep2->GetXaxis()->SetTitle("ADC (noise surpressed)");
+  fDiagStep2->GetYaxis()->SetTitle("#Delta E [GeV]");
+  fDiagStep3  = new TH2F("diagStep3",  "Edep vs Edep path corrected",
+                       100, 0., 2., 100, 0., 2.);
+  fDiagStep3->SetDirectory(0);
+  fDiagStep3->GetXaxis()->SetTitle("#Delta E [GeV]");
+  fDiagStep3->GetYaxis()->SetTitle("#Delta E/#Delta x #times #delta x [GeV]");
+  fDiagStep4  = new TH2F("diagStep4",  "Edep vs Multiplicity deduced", 
+                       100, 0., 2., 100, -.1, 19.9);
+  fDiagStep4->SetDirectory(0);
+  fDiagStep4->GetXaxis()->SetTitle("#Delta E/#Delta x #times #delta x [GeV]");
+  fDiagStep4->GetYaxis()->SetTitle("Multiplicity");
+  fDiagAll    = new TH2F("diagAll",    "Read ADC vs Multiplicity deduced", 
+                        1024, -.5, 1023.5, 100, -.1, 19.9);
+  fDiagAll->SetDirectory(0);
+  fDiagAll->GetXaxis()->SetTitle("ADC (read)");
+  fDiagAll->GetYaxis()->SetTitle("Multiplicity");
+}
+
+//____________________________________________________________________
+void 
+AliFMDReconstructor::ConvertDigits(AliRawReader* reader, 
+                                  TTree* digitsTree) const
+{
+  // Convert Raw digits to AliFMDDigit's in a tree 
+  AliFMDDebug(2, ("Reading raw data into digits tree"));
+  AliFMDRawReader rawRead(reader, digitsTree);
+  // rawRead.SetSampleRate(fFMD->GetSampleRate());
+  rawRead.Exec();
+}
+
+//____________________________________________________________________
+void 
+AliFMDReconstructor::GetVertex() const
+{
+  // Return the vertex to use. 
+  // This is obtained from the ESD object. 
+  // If not found, a warning is issued.
+  fVertexType    = kNoVertex;
+  fCurrentVertex = 0;
+  if (fESD) {
+    const AliESDVertex* vertex = fESD->GetVertex();
+    if (vertex) {
+      AliFMDDebug(2, ("Got vertex from ESD: %f", vertex->GetZv()));
+      fCurrentVertex = vertex->GetZv();
+      fVertexType    = kESDVertex;
+      return;
+    }
+  }
+  AliWarning("Didn't get any vertex from ESD or generator");
+}
+  
+
+//____________________________________________________________________
+void 
+AliFMDReconstructor::Reconstruct(AliRawReader* /*reader*/, TTree*) const
+{
+  // Reconstruct directly from raw data (no intermediate output on
+  // digit tree or rec point tree).  
+  // Parameters: 
+  //   reader  Raw event reader 
+  //   ctree    Not used. 
+  AliError("Method is not used");
+#if 0
+  TClonesArray*   array = new TClonesArray("AliFMDDigit");
+  AliFMDRawReader rawRead(reader, 0);
+  rawRead.ReadAdcs(array);
+  ProcessDigits(array);
+  array->Delete();
+  delete array;
 #endif
-      runLoader->GetEvent(ievent) ;
-      //event z-vertex for correction eta-rad dependence      
-      AliHeader *header = runLoader->GetHeader();
-      AliGenEventHeader* genHeader = header->GenEventHeader();
-      TArrayF *o = new TArrayF(3); 
-      genHeader->PrimaryVertex(*o);
-      Float_t zVertex=o->At(2);
-
-      for (Int_t i=0; i<5; i++)
-        hTotal[i+1]->Reset();
-      
-      retval = plFMD->LoadDigits("READ"); 
-      if (retval)
-       {
-         Error("Exec","Error occured while loading digits. Exiting.");
-         return;
-       }
-      
-      AliFMD * fFMD = (AliFMD *)gAlice->GetDetector("FMD");
-      TClonesArray *fReconParticles=fFMD->ReconParticles();
-      TClonesArray *fDigits=fFMD->Digits();
+}
+
+//____________________________________________________________________
+void 
+AliFMDReconstructor::Reconstruct(TTree* digitsTree, 
+                                TTree* clusterTree) const 
+{
+  // Reconstruct event from digits in tree 
+  // Get the FMD branch holding the digits. 
+  // FIXME: The vertex may not be known yet, so we may have to move
+  // some of this to FillESD. 
+  AliFMDDebug(2, ("Reconstructing from digits in a tree"));
+  GetVertex();
+
+  TBranch *digitBranch = digitsTree->GetBranch("FMD");
+  if (!digitBranch) {
+    Error("Exec", "No digit branch for the FMD found");
+    return;
+  }
+  TClonesArray* digits = new TClonesArray("AliFMDDigit");
+  digitBranch->SetAddress(&digits);
+
+  if (fMult)   fMult->Clear();
+  if (fESDObj) fESDObj->Clear();
+  
+  fNMult = 0;
+  fTreeR = clusterTree;
+  fTreeR->Branch("FMD", &fMult);
+  
+  AliFMDDebug(5, ("Getting entry 0 from digit branch"));
+  digitBranch->GetEntry(0);
+  
+  AliFMDDebug(5, ("Processing digits"));
+  ProcessDigits(digits);
+
+  Int_t written = clusterTree->Fill();
+  AliFMDDebug(10, ("Filled %d bytes into cluster tree", written));
+  digits->Delete();
+  delete digits;
+}
  
-      TTree* treeD = plFMD->TreeD();
-      if (treeD == 0x0)
-       {
-         Error("Exec","Can not get Tree with Digits. Nothing to reconstruct - Exiting");
-         return;
-       }
-      
-      TBranch *brDigits=0;
-           
-      brDigits=treeD->GetBranch("FMD");
-
-      if (brDigits) {
-       brDigits->SetAddress(&fDigits);
-      }else{
-       cerr<<"EXEC Branch FMD digits not found"<<endl;
-       return;
-      } 
-         
-      if(plFMD->TreeR()==0) plFMD->MakeTree("R");
-
-      //Make branches
-      fFMD->MakeBranch("R");
 
-      
-      Int_t zeroADC=6;
-      // read Digits 
-      AliFMDdigit  *fmdDigit;
-       if (fFMD)
-       {
-         plFMD->TreeD()->GetEvent(0); 
-                 
-         Int_t nDigits=fDigits->GetEntries();
-         Int_t recParticles[6];
-         Int_t nRecPart=0 ;
-         Int_t zeroPads=0;
-         Int_t numberOfPads=0;
-         Int_t pedestal;
-         Float_t channelWidth=(22400*50)/1024;
-         for (Int_t digit=0;digit<nDigits;digit++) 
-           {
-             fmdDigit=(AliFMDdigit*)fDigits->UncheckedAt(digit);    
-             ivol=fmdDigit->Volume();
-             iSector=fmdDigit->NumberOfSector();
-             iRing=fmdDigit->NumberOfRing();
-             pedestal=Int_t(gRandom->Gaus(500,250));
-             padADC= fmdDigit->ADCsignal()
-               -Int_t(Float_t(pedestal)/channelWidth);
-             if (padADC<0) padADC=0;
-              hTotal[ivol]->Fill(iSector,iRing,padADC);
-           } //digit loop
-
-         //reconstruct multiplicity in 0.1 eta according Poisson distribution 
-
-         Int_t rmin=0; Int_t rmax=0; 
-         Int_t smin=0; Int_t smax=0; 
-         for (ivol=0; ivol<knumVolumes; ivol++)
-           {
-             Float_t ring2number=Float_t (numberOfRings[ivol])/
-               (rout[ivol]-rin[ivol]);
-             Float_t realZ=zVertex+z[ivol];
-             theta=TMath::ATan(rout[ivol]/TMath::Abs(realZ));
-             etain = - TMath::Log( TMath::Tan(theta/2.));
-             theta=TMath::ATan(rin[ivol]/TMath::Abs(realZ));
-             etaout=- TMath::Log( TMath::Tan(theta/2.));
-             numberOfEtaIntervals[ivol]=Int_t((etaout-etain)*10)-1;
-             eta=etain;
-             for (Int_t e1=0;e1<=numberOfEtaIntervals[ivol];e1++) 
-               {
-                 theta = 2.*TMath::ATan (TMath::Exp (-eta));
-                 Float_t radmin = TMath::Abs(realZ) * (TMath::Tan (theta));
-                 rmax= Int_t ( (radmin-rin[ivol])*ring2number+0.5);
-                 eta=eta+0.1;
-                 theta = 2.*TMath::ATan (TMath::Exp (-eta));
-                 rad = TMath::Abs(realZ) * (TMath::Tan (theta));
-                 rmin=Int_t( (rad-rin[ivol])*ring2number+0.5);
-                 
-                 zeroPads=0;
-                 smin=0;
-                 smax=numberOfSectors[ivol]; 
-                 numberOfPads=(rmax-rmin)*(smax-smin);
-                 for (Int_t iring=rmin; iring<rmax; iring++) 
-                   {
-                     for 
-                       (Int_t isector=0;
-                        isector<numberOfSectors[ivol]; 
-                        isector++) 
-                       {
-                         if(hTotal[ivol+1]->GetBinContent(isector+1,iring+1)
-                            <zeroADC) zeroPads++;}
-                     
-                   } //ring
-                 Float_t numberOfPads=Float_t(smax-smin)*Float_t(rmax-rmin);
-
-                 Double_t lambda=-TMath::Log(Double_t(zeroPads)/numberOfPads);
-                 Int_t fRecon=Int_t (lambda*numberOfPads+0.5);
-                 recParticles[0]=ivol+1;
-                 recParticles[1]=smin;
-                 recParticles[2]=smax;
-                 recParticles[3]=rmin;
-                 recParticles[4]=rmax;
-                 recParticles[5]= fRecon;
-                 new((*fReconParticles)[nRecPart++])   AliFMDReconstParticles(recParticles);             
-                 
-
-                } // eta
-            } // volume
-          
-       }//if FMD
-       plFMD->TreeR()->Reset();
-       plFMD->TreeR()->Fill(); 
-       plFMD->WriteRecPoints("OVERWRITE");
-       plFMD->UnloadDigits();
-    } //event loop
-  plFMD->UnloadRecPoints();
-#ifdef DEBUG
-  Info(" Exec"," finished");
-#endif
-  //  delete hTotal[10]; 
+//____________________________________________________________________
+void
+AliFMDReconstructor::ProcessDigits(TClonesArray* digits) const
+{
+  // For each digit, find the pseudo rapdity, azimuthal angle, and
+  // number of corrected ADC counts, and pass it on to the algorithms
+  // used. 
+  Int_t nDigits = digits->GetEntries();
+  AliFMDDebug(1, ("Got %d digits", nDigits));
+  fESDObj->SetNoiseFactor(fNoiseFactor);
+  fESDObj->SetAngleCorrected(fAngleCorrect);
+  for (Int_t i = 0; i < nDigits; i++) {
+    AliFMDDigit* digit = static_cast<AliFMDDigit*>(digits->At(i));
+    AliFMDParameters* param  = AliFMDParameters::Instance();
+    // Check that the strip is not marked as dead 
+    if (param->IsDead(digit->Detector(), digit->Ring(), 
+                     digit->Sector(), digit->Strip())) {
+      AliFMDDebug(10, ("FMD%d%c[%2d,%3d] is dead", digit->Detector(), 
+                       digit->Ring(), digit->Sector(), digit->Strip()));
+      continue;
+    }
+
+    // digit->Print();
+    // Get eta and phi 
+    Float_t eta, phi;
+    PhysicalCoordinates(digit, eta, phi);
+    
+    // Substract pedestal. 
+    UShort_t counts   = SubtractPedestal(digit);
+    
+    // Gain match digits. 
+    Double_t edep     = Adc2Energy(digit, eta, counts);
+    
+    // Make rough multiplicity 
+    Double_t mult     = Energy2Multiplicity(digit, edep);
+    
+    AliFMDDebug(10, ("FMD%d%c[%2d,%3d]: "
+                     "ADC: %d, Counts: %d, Energy: %f, Mult: %f", 
+                     digit->Detector(), digit->Ring(), digit->Sector(),
+                     digit->Strip(), digit->Counts(), counts, edep, mult));
+    
+    // Create a `RecPoint' on the output branch. 
+    if (fMult) {
+      AliFMDRecPoint* m = 
+       new ((*fMult)[fNMult]) AliFMDRecPoint(digit->Detector(), 
+                                             digit->Ring(), 
+                                             digit->Sector(),
+                                             digit->Strip(),
+                                             eta, phi, 
+                                             edep, mult);
+      (void)m; // Suppress warnings about unused variables. 
+      fNMult++;
+    }
+    
+    fESDObj->SetMultiplicity(digit->Detector(), digit->Ring(), 
+                            digit->Sector(),  digit->Strip(), mult);
+    fESDObj->SetEta(digit->Detector(), digit->Ring(), 
+                   digit->Sector(),  digit->Strip(), eta);
+
+    if (fDiagAll) fDiagAll->Fill(digit->Counts(), mult);  
+  }
+}
 
+//____________________________________________________________________
+UShort_t
+AliFMDReconstructor::SubtractPedestal(AliFMDDigit* digit) const
+{
+  // Member function to subtract the pedestal from a digit
+  // This implementation does nothing, but a derived class could over
+  // load this to subtract a pedestal that was given in a database or
+  // something like that. 
+
+  Int_t             counts = 0;
+  Int_t             adc    = 0;
+  AliFMDParameters* param  = AliFMDParameters::Instance();
+  Float_t           ped    = param->GetPedestal(digit->Detector(), 
+                                               digit->Ring(), 
+                                               digit->Sector(), 
+                                               digit->Strip());
+  Float_t           noise  = param->GetPedestalWidth(digit->Detector(), 
+                                                    digit->Ring(), 
+                                                    digit->Sector(), 
+                                                    digit->Strip());
+  AliFMDDebug(15, ("Subtracting pedestal %f from signal %d", 
+                  ped, digit->Counts()));
+  if (digit->Count3() > 0)      adc = digit->Count3();
+  else if (digit->Count2() > 0) adc = digit->Count2();
+  else                          adc = digit->Count1();
+  counts = TMath::Max(Int_t(adc - ped), 0);
+  if (counts < noise * fNoiseFactor) counts = 0;
+  if (counts > 0) AliFMDDebug(15, ("Got a hit strip"));
+  if (fDiagStep1) fDiagStep1->Fill(adc, counts);
+  
+  return  UShort_t(counts);
+}
+
+//____________________________________________________________________
+Float_t
+AliFMDReconstructor::Adc2Energy(AliFMDDigit* digit, 
+                               Float_t      eta, 
+                               UShort_t     count) const
+{
+  // Converts number of ADC counts to energy deposited. 
+  // Note, that this member function can be overloaded by derived
+  // classes to do strip-specific look-ups in databases or the like,
+  // to find the proper gain for a strip. 
+  // 
+  // In this simple version, we calculate the energy deposited as 
+  // 
+  //    EnergyDeposited = cos(theta) * gain * count
+  // 
+  // where 
+  // 
+  //           Pre_amp_MIP_Range
+  //    gain = ----------------- * Energy_deposited_per_MIP
+  //           ADC_channel_size    
+  // 
+  // is constant and the same for all strips.
+  if (count <= 0) return 0;
+  AliFMDParameters* param = AliFMDParameters::Instance();
+  Float_t           gain  = param->GetPulseGain(digit->Detector(), 
+                                               digit->Ring(), 
+                                               digit->Sector(), 
+                                               digit->Strip());
+  AliFMDDebug(15, ("Converting counts %d to energy via factor %f", 
+                   count, gain));
+
+  Double_t edep  = count * gain;
+  if (fDiagStep2) fDiagStep2->Fill(count, edep);  
+  if (fAngleCorrect) {
+    Double_t theta = 2 * TMath::ATan(TMath::Exp(-eta));
+    Double_t corr  = TMath::Abs(TMath::Cos(theta));
+    Double_t cedep = corr * edep;
+    AliFMDDebug(10, ("correcting for path %f * %f = %f (eta=%f, theta=%f)",
+                     edep, corr, cedep, eta, theta));
+    if (fDiagStep3) fDiagStep3->Fill(edep, cedep);  
+    edep = cedep;
+  }
+  return edep;
 }
 
+//____________________________________________________________________
+Float_t
+AliFMDReconstructor::Energy2Multiplicity(AliFMDDigit* /* digit */, 
+                                        Float_t      edep) const
+{
+  // Converts an energy signal to number of particles. 
+  // Note, that this member function can be overloaded by derived
+  // classes to do strip-specific look-ups in databases or the like,
+  // to find the proper gain for a strip. 
+  // 
+  // In this simple version, we calculate the multiplicity as 
+  // 
+  //   multiplicity = Energy_deposited / Energy_deposited_per_MIP
+  // 
+  // where 
+  //
+  //   Energy_deposited_per_MIP = 1.664 * SI_density * SI_thickness 
+  // 
+  // is constant and the same for all strips 
+  AliFMDParameters* param   = AliFMDParameters::Instance();
+  Double_t          edepMIP = param->GetEdepMip();
+  Float_t           mult    = edep / edepMIP;
+  if (edep > 0) 
+    AliFMDDebug(15, ("Translating energy %f to multiplicity via "
+                    "divider %f->%f", edep, edepMIP, mult));
+  if (fDiagStep4) fDiagStep4->Fill(edep, mult);  
+  return mult;
+}
 
-//_____________________________________________________________________________
-void AliFMDReconstructor::FillESD(AliRunLoader* /*runLoader*/, 
-                                 AliESD* /*esd*/) const
+//____________________________________________________________________
+void
+AliFMDReconstructor::PhysicalCoordinates(AliFMDDigit* digit, 
+                                        Float_t& eta, 
+                                        Float_t& phi) const
 {
-// nothing to be done
+  // Get the eta and phi of a digit 
+  // 
+  // Get geometry. 
+  AliFMDGeometry* geom = AliFMDGeometry::Instance();
+  Double_t x, y, z, r, theta;
+  geom->Detector2XYZ(digit->Detector(), digit->Ring(), digit->Sector(), 
+                   digit->Strip(), x, y, z);
+  // Correct for vertex offset. 
+  z     += fCurrentVertex;
+  phi   =  TMath::ATan2(y, x);
+  r     =  TMath::Sqrt(y * y + x * x);
+  theta =  TMath::ATan2(r, z);
+  eta   = -TMath::Log(TMath::Tan(theta / 2));
+}
 
+      
+
+//____________________________________________________________________
+void 
+AliFMDReconstructor::FillESD(TTree*  /* digitsTree */, 
+                            TTree*  /* clusterTree */,
+                            AliESDEvent* esd) const
+{
+  // nothing to be done
+  // FIXME: The vertex may not be known when Reconstruct is executed,
+  // so we may have to move some of that member function here. 
+  AliFMDDebug(2, ("Calling FillESD with two trees and one ESD"));
+  // fESDObj->Print();
+
+  if (esd) { 
+    AliFMDDebug(2, ("Writing FMD data to ESD tree"));
+    esd->SetFMDData(fESDObj);
+  }
+
+  if (!fDiagnostics || !esd) return;
+  static bool first = true;
+  // This is most likely NOT the event number you'd like to use. It
+  // has nothing to do with the 'real' event number. 
+  // - That's OK.  We just use it for the name of the directory -
+  // nothing else.  Christian
+  Int_t evno = esd->GetEventNumberInFile(); 
+  AliFMDDebug(1, ("Writing diagnostics histograms to FMD.Diag.root/%03d",evno));
+  TFile f("FMD.Diag.root", (first ? "RECREATE" : "UPDATE"));
+  first = false;
+  f.cd(); 
+  TDirectory* d = f.mkdir(Form("%03d", evno), 
+                         Form("Diagnostics histograms for event # %d", evno));
+  d->cd();
+  if (fDiagStep1) fDiagStep1->Write();
+  if (fDiagStep2) fDiagStep2->Write();
+  if (fDiagStep3) fDiagStep3->Write();
+  if (fDiagStep4) fDiagStep4->Write();
+  if (fDiagAll)   fDiagAll->Write();
+  d->Write();
+  f.Write();
+  f.Close();
+
+  if (fDiagStep1) fDiagStep1->Reset();
+  if (fDiagStep2) fDiagStep2->Reset();
+  if (fDiagStep3) fDiagStep3->Reset();
+  if (fDiagStep4) fDiagStep4->Reset();
+  if (fDiagAll)   fDiagAll->Reset();
+}
+
+//____________________________________________________________________
+void
+AliFMDReconstructor::FillESD(AliRawReader*, TTree* clusterTree, 
+                            AliESDEvent* esd) const
+{
+  TTree* dummy = 0;
+  FillESD(dummy, clusterTree, esd);
 }
 
+//____________________________________________________________________
+//
+// EOF
+//