]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - FMD/AliFMDReconstructor.cxx
Coding conventions (Christian)
[u/mrichter/AliRoot.git] / FMD / AliFMDReconstructor.cxx
index 2c614666cb5dac53eca53f2d6a3f17743451e123..788655eb71a585dd0ccdf3a3783991ccb24e78ca 100644 (file)
  * about the suitability of this software for any purpose. It is          *
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
-
 /* $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 AliFMDMult (reconstructed
-// multiplicity) from of Digits
+// 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). 
 //
-// From the cached values it then calculates the number of particles
-// that hit a region of the FMDs, as specified by the user. 
-//
-// The reconstruction can be done in two ways: Either via counting the
-// number of empty strips (Poisson method), or by converting the ADC
-// signal to an energy deposition, and then dividing by the typical
-// energy loss of a particle.
-// 
-//      +---------------------+       +---------------------+
-//      | AliFMDReconstructor |<>-----| AliFMDMultAlgorithm |
-//      +---------------------+       +---------------------+
-//                                               ^
-//                                               |
-//                                   +-----------+---------+
-//                                   |                     |
-//                         +-------------------+   +------------------+
-//                         | AliFMDMultPoisson |   | AliFMDMultNaiive |
-//                         +-------------------+   +------------------+
-//
-// AliFMDReconstructor acts as a manager class.  It contains a list of
-// AliFMDMultAlgorithm objects.  The call graph looks something like 
-//
-//
-//       +----------------------+            +----------------------+
-//       | :AliFMDReconstructor |            | :AliFMDMultAlgorithm |
-//       +----------------------+            +----------------------+
-//                  |                                  |
-//    Reconstruct  +-+                                 |
-//    ------------>| |                         PreRun +-+
-//                 | |------------------------------->| |   
-//                 | |                                +-+
-//                 | |-----+ (for each event)          |
-//                 | |     | *ProcessEvent             |
-//                 |+-+    |                           |
-//                 || |<---+                 PreEvent +-+
-//                 || |------------------------------>| |      
-//                 || |                               +-+
-//                 || |-----+                          |
-//                 || |     | ProcessDigits            |
-//                 ||+-+    |                          |
-//                 ||| |<---+                          |
-//                 ||| |         *ProcessDigit(digit) +-+
-//                 ||| |----------------------------->| |
-//                 ||| |                              +-+
-//                 ||+-+                               |
-//                 || |                     PostEvent +-+
-//                 || |------------------------------>| |
-//                 || |                               +-+
-//                 |+-+                                |
-//                 | |                        PostRun +-+
-//                 | |------------------------------->| |
-//                 | |                                +-+
-//                 +-+                                 |
-//                  |                                  |
-//
-//
-// 
 //-- Authors: Evgeny Karpechev(INR) and Alla Maevsksia
 //  Latest changes by Christian Holm Christensen <cholm@nbi.dk>
 //
 #include <AliLog.h>                        // ALILOG_H
 #include <AliRun.h>                        // ALIRUN_H
 #include <AliRunLoader.h>                  // ALIRUNLOADER_H
-#include <AliLoader.h>                     // ALILOADER_H
 #include <AliHeader.h>                     // ALIHEADER_H
-#include <AliRawReader.h>                  // ALIRAWREADER_H
 #include <AliGenEventHeader.h>             // ALIGENEVENTHEADER_H
-#include "AliFMD.h"                       // ALIFMD_H
 #include "AliFMDGeometry.h"                // ALIFMDGEOMETRY_H
 #include "AliFMDParameters.h"              // ALIFMDPARAMETERS_H
-#include "AliFMDDetector.h"                // ALIFMDDETECTOR_H
-#include "AliFMDRing.h"                    // ALIFMDRING_H
 #include "AliFMDDigit.h"                   // ALIFMDDIGIT_H
 #include "AliFMDReconstructor.h"           // ALIFMDRECONSTRUCTOR_H
-#include "AliFMDRawStream.h"               // ALIFMDRAWSTREAM_H
 #include "AliFMDRawReader.h"               // ALIFMDRAWREADER_H
-#include "AliFMDMultAlgorithm.h"          // ALIFMDMULTALGORITHM_H
-#include "AliFMDMultPoisson.h"            // ALIFMDMULTPOISSON_H
-#include "AliFMDMultNaiive.h"             // ALIFMDMULTNAIIVE_H
+#include "AliFMDRecPoint.h"               // ALIFMDMULTNAIIVE_H
+#include "AliESD.h"                       // ALIESD_H
+#include <AliESDFMD.h>                    // ALIESDFMD_H
+class AliRawReader;
 
 //____________________________________________________________________
 ClassImp(AliFMDReconstructor)
@@ -116,45 +56,28 @@ ClassImp(AliFMDReconstructor)
 //____________________________________________________________________
 AliFMDReconstructor::AliFMDReconstructor() 
   : AliReconstructor(),
-    fPedestal(0), 
-    fPedestalWidth(0),
-    fPedestalFactor(0)
+    fMult(0x0), 
+    fNMult(0),
+    fTreeR(0x0),
+    fCurrentVertex(0),
+    fESDObj(0x0),
+    fESD(0x0)
 {
-  // Make a new FMD reconstructor object - default CTOR.
-  AliFMDParameters* pars = AliFMDParameters::Instance();
-  fPedestal       = pars->GetPedestal();
-  fPedestalWidth  = pars->GetPedestalWidth();
-  fPedestalFactor = pars->GetPedestalFactor();
-  
-  fAlgorithms.Add(new AliFMDMultNaiive);
-  fAlgorithms.Add(new AliFMDMultPoisson);
-
-  TIter next(&fAlgorithms);
-  AliFMDMultAlgorithm* algorithm = 0;
-  while ((algorithm = static_cast<AliFMDMultAlgorithm*>(next()))) 
-    algorithm->PreRun(0);
+  // Make a new FMD reconstructor object - default CTOR.  
 }
   
 
 //____________________________________________________________________
 AliFMDReconstructor::AliFMDReconstructor(const AliFMDReconstructor& other) 
-  : AliReconstructor(),
-    fPedestal(0), 
-    fPedestalWidth(0),
-    fPedestalFactor(0)
+  : AliReconstructor(), 
+    fMult(other.fMult),
+    fNMult(other.fNMult),
+    fTreeR(other.fTreeR),
+    fCurrentVertex(other.fCurrentVertex),
+    fESDObj(other.fESDObj),
+    fESD(other.fESD)
 {
   // Copy constructor 
-  fPedestal       = other.fPedestal;
-  fPedestalWidth  = other.fPedestalWidth;
-  fPedestalFactor = other.fPedestalFactor;
-
-  
-  fAlgorithms.Delete();
-  TIter next(&(other.fAlgorithms));
-  AliFMDMultAlgorithm* algorithm = 0;
-  while ((algorithm = static_cast<AliFMDMultAlgorithm*>(next()))) 
-    fAlgorithms.Add(algorithm);
-  fAlgorithms.SetOwner(kFALSE);
 }
   
 
@@ -163,17 +86,12 @@ AliFMDReconstructor&
 AliFMDReconstructor::operator=(const AliFMDReconstructor& other) 
 {
   // Assignment operator
-  fPedestal       = other.fPedestal;
-  fPedestalWidth  = other.fPedestalWidth;
-  fPedestalFactor = other.fPedestalFactor;
-
-  fAlgorithms.Delete();
-  TIter next(&(other.fAlgorithms));
-  AliFMDMultAlgorithm* algorithm = 0;
-  while ((algorithm = static_cast<AliFMDMultAlgorithm*>(next()))) 
-    fAlgorithms.Add(algorithm);
-  fAlgorithms.SetOwner(kFALSE);
-
+  fMult   = other.fMult;
+  fNMult = other.fNMult;
+  fTreeR = other.fTreeR;
+  fCurrentVertex = other.fCurrentVertex;
+  fESDObj = other.fESDObj;
+  fESD = other.fESD;
   return *this;
 }
 
@@ -181,7 +99,9 @@ AliFMDReconstructor::operator=(const AliFMDReconstructor& other)
 AliFMDReconstructor::~AliFMDReconstructor() 
 {
   // Destructor 
-  fAlgorithms.Delete();
+  if (fMult)   fMult->Delete();
+  if (fMult)   delete fMult;
+  if (fESDObj) delete fESDObj;
 }
 
 //____________________________________________________________________
@@ -190,26 +110,49 @@ AliFMDReconstructor::Init(AliRunLoader* runLoader)
 {
   // Initialize the reconstructor 
   AliDebug(1, Form("Init called with runloader 0x%x", runLoader));
+  // Initialize the geometry 
+  AliFMDGeometry* geom = AliFMDGeometry::Instance();
+  geom->Init();
+  geom->InitTransformations();
+
+  // Initialize the parameters
+  AliFMDParameters* param = AliFMDParameters::Instance();
+  param->Init();
+  
+  // Current vertex position
   fCurrentVertex = 0;
+  // Create array of reconstructed strip multiplicities 
+  fMult = new TClonesArray("AliFMDRecPoint", 51200);
+  // Create ESD output object 
+  fESDObj = new AliESDFMD;
+  
+  // Check that we have a run loader
   if (!runLoader) { 
     Warning("Init", "No run loader");
     return;
   }
+
+  // Check if we can get the header tree 
   AliHeader* header = runLoader->GetHeader();
   if (!header) {
     Warning("Init", "No header");
     return;
   }
+
+  // Check if we can get a simulation header 
   AliGenEventHeader* eventHeader = header->GenEventHeader();
-  if (!eventHeader) {
-    Warning("Init", "no event header");
-    return;
+  if (eventHeader) {
+    TArrayF vtx;
+    eventHeader->PrimaryVertex(vtx);
+    fCurrentVertex = vtx[2];
+    AliDebug(1, Form("Primary vertex Z coordinate for event # %d/%d is %f", 
+                    header->GetRun(), header->GetEvent(), fCurrentVertex));
+    Warning("Init", "no generator event header");
+  }
+  else {
+    Warning("Init", "No generator event header - "
+           "perhaps we get the vertex from ESD?");
   }
-  TArrayF vtx;
-  eventHeader->PrimaryVertex(vtx);
-  fCurrentVertex = vtx[2];
-  AliDebug(1, Form("Primary vertex Z coordinate for event # %d/%d is %f", 
-                  header->GetRun(), header->GetEvent(), fCurrentVertex));
 }
 
 //____________________________________________________________________
@@ -218,6 +161,7 @@ AliFMDReconstructor::ConvertDigits(AliRawReader* reader,
                                   TTree* digitsTree) const
 {
   // Convert Raw digits to AliFMDDigit's in a tree 
+  AliDebug(1, "Reading raw data into digits tree");
   AliFMDRawReader rawRead(reader, digitsTree);
   // rawRead.SetSampleRate(fFMD->GetSampleRate());
   rawRead.Exec();
@@ -233,30 +177,43 @@ AliFMDReconstructor::Reconstruct(TTree* digitsTree,
   // FIXME: The vertex may not be known yet, so we may have to move
   // some of this to FillESD. 
   AliDebug(1, "Reconstructing from digits in a tree");
-  
+#if 1
+  if (fESD) {
+    const AliESDVertex* vertex = fESD->GetVertex();
+    if (vertex) {
+      AliDebug(1, Form("Got vertex from ESD: %f", vertex->GetZv()));
+      fCurrentVertex = vertex->GetZv();
+    }
+  }
+#endif  
   TBranch *digitBranch = digitsTree->GetBranch("FMD");
-  TClonesArray* digits = new TClonesArray("AliFMDDigit");
   if (!digitBranch) {
     Error("Exec", "No digit branch for the FMD found");
     return;
   }
+  TClonesArray* digits = new TClonesArray("AliFMDDigit");
   digitBranch->SetAddress(&digits);
 
-  TIter next(&fAlgorithms);
-  AliFMDMultAlgorithm* algorithm = 0;
-  while ((algorithm = static_cast<AliFMDMultAlgorithm*>(next()))) 
-    algorithm->PreEvent(clusterTree, fCurrentVertex);
+  if (fMult)   fMult->Clear();
+  if (fESDObj) fESDObj->Clear();
+  
+  fNMult = 0;
+  fTreeR = clusterTree;
+  fTreeR->Branch("FMD", &fMult);
+  
+  AliDebug(5, "Getting entry 0 from digit branch");
   digitBranch->GetEntry(0);
   
+  AliDebug(5, "Processing digits");
   ProcessDigits(digits);
 
-  next.Reset();
-  algorithm = 0;
-  while ((algorithm = static_cast<AliFMDMultAlgorithm*>(next()))) 
-    algorithm->PostEvent();
-  clusterTree->Fill();
+  Int_t written = clusterTree->Fill();
+  AliDebug(10, Form("Filled %d bytes into cluster tree", written));
+  digits->Delete();
+  delete digits;
 }
  
+
 //____________________________________________________________________
 void
 AliFMDReconstructor::ProcessDigits(TClonesArray* digits) const
@@ -268,38 +225,48 @@ AliFMDReconstructor::ProcessDigits(TClonesArray* digits) const
   AliDebug(1, Form("Got %d digits", nDigits));
   for (Int_t i = 0; i < nDigits; i++) {
     AliFMDDigit* digit = static_cast<AliFMDDigit*>(digits->At(i));
-    AliFMDGeometry* fmd = AliFMDGeometry::Instance();
-    AliFMDDetector* subDetector = fmd->GetDetector(digit->Detector());
-    if (!subDetector) { 
-      Warning("ProcessDigits", "Unknown detector: FMD%d" , digit->Detector());
-      continue;
-    }
-    
-    AliFMDRing* ring  = subDetector->GetRing(digit->Ring());
-    Float_t     ringZ = subDetector->GetRingZ(digit->Ring());
-    if (!ring) {
-      Warning("ProcessDigits", "Unknown ring: FMD%d%c", digit->Detector(), 
-             digit->Ring());
-      break;
-    }
+    AliFMDParameters* param  = AliFMDParameters::Instance();
+    // Check that the strip is not marked as dead 
+    if (param->IsDead(digit->Detector(), digit->Ring(), 
+                     digit->Sector(), digit->Strip())) continue;
+
+    // digit->Print();
+    // Get eta and phi 
+    Float_t eta, phi;
+    PhysicalCoordinates(digit, eta, phi);
     
-    Float_t  realZ    = fCurrentVertex + ringZ;
-    Float_t  stripR   = ((ring->GetHighR() - ring->GetLowR()) 
-                        / ring->GetNStrips() * (digit->Strip() + .5) 
-                        + ring->GetLowR());
-    Float_t  theta    = TMath::ATan2(stripR, realZ);
-    Float_t  phi      = (2 * TMath::Pi() / ring->GetNSectors() 
-                        * (digit->Sector() + .5));
-    Float_t  eta      = -TMath::Log(TMath::Tan(theta / 2));
+    // Substract pedestal. 
     UShort_t counts   = SubtractPedestal(digit);
     
-    TIter next(&fAlgorithms);
-    AliFMDMultAlgorithm* algorithm = 0;
-    while ((algorithm = static_cast<AliFMDMultAlgorithm*>(next()))) 
-      algorithm->ProcessDigit(digit, eta, phi, counts);
+    // Gain match digits. 
+    Double_t edep     = Adc2Energy(digit, eta, counts);
+    
+    // Make rough multiplicity 
+    Double_t mult     = Energy2Multiplicity(digit, edep);
+    
+    AliDebug(10, Form("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. 
+    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);
   }
 }
-      
+
 //____________________________________________________________________
 UShort_t
 AliFMDReconstructor::SubtractPedestal(AliFMDDigit* digit) const
@@ -309,25 +276,182 @@ AliFMDReconstructor::SubtractPedestal(AliFMDDigit* digit) const
   // load this to subtract a pedestal that was given in a database or
   // something like that. 
 
-  Int_t counts = 0;
-  Float_t ped = fPedestal + fPedestalFactor * fPedestalWidth;
+  Int_t             counts = 0;
+  AliFMDParameters* param  = AliFMDParameters::Instance();
+  Float_t           pedM   = param->GetPedestal(digit->Detector(), 
+                                               digit->Ring(), 
+                                               digit->Sector(), 
+                                               digit->Strip());
+  AliDebug(10, Form("Subtracting pedestal %f from signal %d", 
+                  pedM, digit->Counts()));
   if (digit->Count3() > 0)      counts = digit->Count3();
   else if (digit->Count2() > 0) counts = digit->Count2();
   else                          counts = digit->Count1();
-  counts = TMath::Max(Int_t(counts - ped), 0);
+  counts = TMath::Max(Int_t(counts - pedM), 0);
+  if (counts > 0) AliDebug(10, "Got a hit strip");
+  
   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.
+
+  // Double_t theta = 2 * TMath::ATan(TMath::Exp(-eta));
+  // Double_t edep  = TMath::Abs(TMath::Cos(theta)) * fGain * count;
+  AliFMDParameters* param = AliFMDParameters::Instance();
+  Float_t           gain  = param->GetPulseGain(digit->Detector(), 
+                                               digit->Ring(), 
+                                               digit->Sector(), 
+                                               digit->Strip());
+  Double_t          edep  = count * gain;
+  AliDebug(10, Form("Converting counts %d to energy via factor %f", 
+                   count, gain));
+  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) 
+    AliDebug(10, Form("Translating energy %f to multiplicity via "
+                    "divider %f->%f", edep, edepMIP, mult));
+  return mult;
+}
+
+//____________________________________________________________________
+void
+AliFMDReconstructor::PhysicalCoordinates(AliFMDDigit* digit, 
+                                        Float_t& eta, 
+                                        Float_t& phi) const
+{
+  // 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 */,
-                            AliESD* /* esd*/) const
+                            AliESD* 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. 
+  AliDebug(1, Form("Calling FillESD with two trees and one ESD"));
+  // fESDObj->Print();
+
+  if (esd) { 
+    AliDebug(1, Form("Writing FMD data to ESD tree"));
+    esd->SetFMDData(fESDObj);
+  }
+}
+
 
+//____________________________________________________________________
+void 
+AliFMDReconstructor::Reconstruct(AliRawReader*,TTree*) const 
+{
+  // Cannot be used.  See member function with same name but with 2
+  // TTree arguments.   Make sure you do local reconstrucion 
+  AliDebug(1, Form("Calling FillESD with loader and tree"));
+  AliError("MayNotUse");
+}
+//____________________________________________________________________
+void 
+AliFMDReconstructor::Reconstruct(AliRunLoader*) const 
+{
+  // Cannot be used.  See member function with same name but with 2
+  // TTree arguments.   Make sure you do local reconstrucion 
+  AliDebug(1, Form("Calling FillESD with loader"));
+  AliError("MayNotUse");
+}
+//____________________________________________________________________
+void 
+AliFMDReconstructor::Reconstruct(AliRunLoader*, AliRawReader*) const 
+{
+  // Cannot be used.  See member function with same name but with 2
+  // TTree arguments.   Make sure you do local reconstrucion 
+  AliDebug(1, Form("Calling FillESD with loader and raw reader"));
+  AliError("MayNotUse");
+}
+//____________________________________________________________________
+void 
+AliFMDReconstructor::FillESD(AliRawReader*,TTree*,AliESD*) const 
+{
+  // Cannot be used.  See member function with same name but with 2
+  // TTree arguments.   Make sure you do local reconstrucion 
+  AliDebug(1, Form("Calling FillESD with raw reader, tree, and ESD"));
+  AliError("MayNotUse");
+}
+//____________________________________________________________________
+void 
+AliFMDReconstructor::FillESD(AliRunLoader*,AliESD*) const
+{
+  // Cannot be used.  See member function with same name but with 2
+  // TTree arguments.   Make sure you do local reconstrucion 
+  AliDebug(1, Form("Calling FillESD with loader and ESD"));
+  AliError("MayNotUse");
+}
+//____________________________________________________________________
+void 
+AliFMDReconstructor::FillESD(AliRunLoader*,AliRawReader*,AliESD*) const 
+{
+  // Cannot be used.  See member function with same name but with 2
+  // TTree arguments.   Make sure you do local reconstrucion 
+  AliDebug(1, Form("Calling FillESD with loader, raw reader, and ESD"));
+  AliError("MayNotUse");
 }
 
 //____________________________________________________________________