AliPhysics  eb0e5d9 (eb0e5d9)
AliCalorimeterUtils.h
Go to the documentation of this file.
1 #ifndef ALICALORIMETERUTILS_H
2 #define ALICALORIMETERUTILS_H
3 /* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
4  * See cxx source for full Copyright notice */
5 
6 //_________________________________________________________________________
19 //_________________________________________________________________________
20 
21 // --- ROOT system ---
22 #include <TObject.h>
23 #include <TString.h>
24 #include <TObjArray.h>
25 class TArrayF;
26 #include <TH2I.h>
27 #include <TGeoMatrix.h>
28 class AliMCEvent;
29 
30 //--- ANALYSIS system ---
31 class AliVEvent;
32 class AliVTrack;
34 class AliAODCaloCluster;
35 class AliVCaloCells;
36 class AliPHOSGeoUtils;
37 class AliEMCALGeometry;
38 class AliAODMCParticle;
39 class TParticle;
40 class AliVParticle;
41 
42 #include "AliEMCALRecoUtils.h"
43 
44 class AliCalorimeterUtils : public TObject {
45 
46  public:
47  AliCalorimeterUtils() ; // ctor
48  virtual ~AliCalorimeterUtils() ;//virtual dtor
49 
50  virtual void InitParameters();
51  virtual void Print(const Option_t * opt) const ;
52 
53  virtual Int_t GetDebug() const { return fDebug ; }
54  virtual void SetDebug(Int_t d) { fDebug = d ; }
55 
56  //virtual void Init();
57 
58  // Cluster contents
59 
60  Bool_t AreNeighbours(Int_t calo, Int_t absId1, Int_t absId2) const ;
61 
62  Bool_t IsClusterSharedByTwoSuperModules(const AliEMCALGeometry * geom,
63  AliVCluster* cluster);
64 
65  Float_t GetECross(Int_t absId, AliVCaloCells* cells, Int_t bc);
66 
67  Bool_t GetFECCorrelatedCellAbsId(Int_t absId, Int_t absIdCorr[4]) const ;
68 
69  Bool_t IsAbsIDsFromTCard(Int_t absId1, Int_t absId2,
70  Int_t & rowDiff, Int_t & colDiff) const ;
71 
72  Int_t GetNumberOfLocalMaxima(AliVCluster* cluster, AliVCaloCells* cells) ;
73 
74  Int_t GetNumberOfLocalMaxima(AliVCluster* cluster, AliVCaloCells* cells,
75  Int_t *absIdList, Float_t *maxEList) ;
76 
77  Float_t GetLocalMaximaCutE() const { return fLocMaxCutE ; }
78  void SetLocalMaximaCutE(Float_t cut) { fLocMaxCutE = cut ; }
79 
82 
83  Int_t GetMaxEnergyCell(AliVCaloCells* cells, AliVCluster* clu, Float_t & fraction) const ;
84 
85  void SplitEnergy(Int_t absId1, Int_t absId2, AliVCluster *cluster, AliVCaloCells* cells,
86  //Float_t & e1, Float_t & e2,
87  AliAODCaloCluster *cluster1, AliAODCaloCluster *cluster2,
88  Int_t nMax, Int_t eventNumber = 0);//, Int_t *absIdList, Float_t *maxEList,
89 
90  void SwitchOnClusterPlot() { fPlotCluster = kTRUE ; }
91  void SwitchOffClusterPlot() { fPlotCluster = kFALSE ; }
92 
93  Float_t GetMCECellClusFracCorrection(Float_t eCell, Float_t eCluster) const ;
95 
99 
100  //------------------------------
101  // Calorimeters Geometry Methods
102  //------------------------------
103 
104  AliEMCALGeometry * GetEMCALGeometry() const { return fEMCALGeo ; }
107  void InitEMCALGeometry() ;
109 
110  AliPHOSGeoUtils * GetPHOSGeometry() const { return fPHOSGeo ; }
111  TString PHOSGeometryName() const { return fPHOSGeoName ; }
112  void SetPHOSGeometryName(TString name) { fPHOSGeoName = name ; }
113  void InitPHOSGeometry() ;
115 
116  void AccessGeometry(AliVEvent* inputEvent) ;
117 
119  TString path = ""){
120  fImportGeometryFromFile = import ;
121  fImportGeometryFilePath = path ; } // EMCAL
122 
123  Bool_t IsMCParticleInCalorimeterAcceptance(Int_t calo, AliVParticle* particle);
124  Bool_t IsMCParticleInCalorimeterAcceptance(Int_t calo, TParticle* particle);
125  Bool_t IsMCParticleInCalorimeterAcceptance(Int_t calo, AliAODMCParticle* particle);
127 
130  void SetEMCALGeometryMatrixInSM(TGeoHMatrix* m, Int_t i) { fEMCALMatrix[i] = m ; }
131 
134  void SetPHOSGeometryMatrixInSM(TGeoHMatrix* m, Int_t i) { fPHOSMatrix[i] = m ; }
135 
136  void GetEMCALSubregion(AliVCluster* clus, AliVCaloCells* cells,
137  Int_t & regEta, Int_t & regPhi) const ;
138 
139  //------------------------------
140  // Bad channels
141  //------------------------------
142 
149 
153 
155 
156  Int_t GetEMCALChannelStatus(Int_t iSM , Int_t iCol, Int_t iRow, Int_t status) const {
157  return fEMCALRecoUtils->GetEMCALChannelStatus(iSM, iCol, iRow, status); }//Channel is ok by default
158 
159  Int_t GetPHOSChannelStatus (Int_t imod, Int_t iCol, Int_t iRow) const {
160  if(fPHOSBadChannelMap) return (Int_t) ((TH2I*)fPHOSBadChannelMap->At(imod))->GetBinContent(iCol,iRow);
161  else return 0 ; }//Channel is ok by default
162 
163  void SetEMCALChannelStatus(Int_t iSM , Int_t iCol, Int_t iRow, Double_t c = 1) {
164  fEMCALRecoUtils->SetEMCALChannelStatus(iSM,iCol,iRow,c) ; }
165 
166  void SetPHOSChannelStatus (Int_t imod, Int_t iCol, Int_t iRow, Double_t c = 1) {
168  ((TH2I*)fPHOSBadChannelMap->At(imod))->SetBinContent(iCol,iRow,c) ; }
169 
171  void SetPHOSChannelStatusMap(Int_t imod , TH2I* h) { fPHOSBadChannelMap ->AddAt(h,imod) ; }
172 
174  TH2I * GetPHOSChannelStatusMap(Int_t imod) const { return (TH2I*)fPHOSBadChannelMap->At(imod) ; }
175 
178 
179  Bool_t ClusterContainsBadChannel(Int_t calo,UShort_t* cellList, Int_t nCells);
180  Bool_t ClusterContainsBadChannel(TString /*calo*/,UShort_t* /*cellList*/, Int_t /*nCells*/) {return kFALSE;} // Stupid thing to do but just to avoid compilation break in AliTrackComparisonESD while I find the authors
181 
182  // Mask clusters in front of frame, EMCAL only
185  if(n > fNMaskCellColumns) { delete [] fMaskCellColumns ; fMaskCellColumns = new Int_t[n] ; }
186  fNMaskCellColumns = n ; }
187  void SetMaskCellColumn(Int_t ipos, Int_t icol) {
188  if(ipos < fNMaskCellColumns) fMaskCellColumns[ipos] = icol;
189  else printf("Not set, position larger than allocated set size first") ; }
190  Bool_t MaskFrameCluster(Int_t iSM, Int_t ieta) const ;
191 
192  //------------------------------
193  // Calorimeter indexes information
194  //------------------------------
195 
196  Int_t GetModuleNumber(AliCaloTrackParticle * particle, AliVEvent* inputEvent) const;
197  Int_t GetModuleNumber(AliVCluster * cluster) const;
198  Int_t GetModuleNumberCellIndexes(Int_t absId, Int_t calo, Int_t & icol, Int_t & irow, Int_t &iRCU) const ;
199  Int_t GetModuleNumberCellIndexesAbsCaloMap(Int_t absId, Int_t calo, Int_t & icol, Int_t & irow, Int_t &iRCU,
200  Int_t & icolAbs, Int_t & irowAbs) const ;
201 
202  //------------------------------
203  // Modules fiducial region
204  //------------------------------
205 
206  Bool_t CheckCellFiducialRegion(AliVCluster* cluster, AliVCaloCells* cells) const ;
207  Bool_t CheckCellFiducialRegion(AliVCluster* cluster, AliVCaloCells* cells, AliVEvent* , Int_t )
208  { return CheckCellFiducialRegion(cluster, cells) ; } // Stupid thing to do but just to avoid compilation break in AliTrackComparisonESD while I find the authors
216 
217  //------------------------------
218  // Recalibration
219  //------------------------------
220 
226 
228 
230  return fEMCALRecoUtils->GetEMCALChannelRecalibrationFactor(iSM , iCol, iRow) ; }
231 
234  return (Float_t) ((TH2F*)fPHOSRecalibrationFactors->At(imod))->GetBinContent(iCol,iRow);
235  else return 1 ; }
236 
239 
242  ((TH2F*)fPHOSRecalibrationFactors->At(imod))->SetBinContent(iCol,iRow,c) ; }
243 
246 
249 
252 
253  void RecalibrateCellTime (Double_t & time, Int_t calo, Int_t absId, Int_t bunchCrossNumber) const ;
254  void RecalibrateCellTimeL1Phase(Double_t & time, Int_t calo, Int_t iSM , Int_t bunchCrossNumber) const;
255  void RecalibrateCellAmplitude (Float_t & amp , Int_t calo, Int_t absId) const ;
256  Float_t RecalibrateClusterEnergy(AliVCluster* cluster, AliVCaloCells * cells);
257  Float_t RecalibrateClusterEnergyWeightCell(AliVCluster* cluster, AliVCaloCells * cells, Float_t energyOrg);
258 
259  //------------------------------
260  // Run dependent energy calibrations (EMCAL)
261  //------------------------------
262 
265 
266  //------------------------------
267  // Time Recalibration (EMCAL)
268  //------------------------------
269 
273 
276 
279 
283 
284  //------------------------------
285  // Time Recalibration - L1 phase (EMCAL)
286  //------------------------------
290 
293 
297 
298  //------------------------------
299  // EMCAL specific utils for the moment
300  //------------------------------
301 
304 
305  void ConfigureEMCALRecoUtils(Bool_t bMC = kFALSE, Bool_t bExotic= kTRUE, Bool_t bNonLin= kFALSE,
306  Bool_t bRecalE= kTRUE , Bool_t bBad = kTRUE, Bool_t bRecalT= kTRUE, Int_t debug = -1);
307 
311  void CorrectClusterEnergy(AliVCluster *cl);
312 
316  void RecalculateClusterPosition(AliVCaloCells* cells, AliVCluster* clu);
317  void RecalculateClusterShowerShapeParameters(AliVCaloCells* cells, AliVCluster* clu){
318  fEMCALRecoUtils->RecalculateClusterShowerShapeParameters((AliEMCALGeometry*)fEMCALGeo, cells, clu) ; }
319 
320  void RecalculateClusterDistanceToBadChannel(AliVCaloCells* cells, AliVCluster* clu){
321  fEMCALRecoUtils->RecalculateClusterDistanceToBadChannel((AliEMCALGeometry*)fEMCALGeo, cells, clu) ; }
322 
324 
325  //------------------------------
326  // *** Track Matching ***
327  //------------------------------
328 
329  AliVTrack * GetMatchedTrack(AliVCluster * cluster, AliVEvent * event, Int_t index = -1) const ;
330 
331  // Recalculation
332 
333  void RecalculateClusterTrackMatching(AliVEvent * event,
334  TObjArray* clusterArray = 0x0,
335  AliMCEvent* mc = 0x0) ;
336 
337  void GetMatchedResiduals(Int_t index, Float_t &dR, Float_t &dZ) {
339 
340  //------------------------------
341  // This could be used for PHOS ...
342  //------------------------------
343 
347 
348  Float_t GetCutZ() const { return fCutZ ; } // PHOS only
349  void SetCutZ(Float_t z) { fCutZ = z ; } // PHOS only
350 
351 
352  Float_t GetCutR() const { return fCutR ; } // PHOS and EMCAL
353  void SetCutR(Float_t r) { fCutR = r ; // PHOS and EMCA
354  fEMCALRecoUtils->SetCutR(r) ; }
355 
356  Float_t GetCutEta() const { return fCutEta ; } // EMCAL only
357  void SetCutEta(Float_t e) { fCutEta = e ; // EMCAL only
358  fEMCALRecoUtils->SetCutEta(e) ; }
359 
360  Float_t GetCutPhi() const { return fCutPhi ; } // EMCAL only
361  void SetCutPhi(Float_t p) { fCutPhi = p ; // EMCAL only
362  fEMCALRecoUtils->SetCutPhi(p) ; }
363 
364  //------------------------------
365  // OADB options settings
366  //------------------------------
367 
368  void AccessOADB(AliVEvent * event) ;
369 
370  TString GetPass() ;
371 
372  void SwitchOnEMCALOADB() { fOADBForEMCAL = kTRUE ; }
373  void SwitchOffEMCALOADB() { fOADBForEMCAL = kFALSE ; }
374 
375  void SwitchOnPHOSOADB() { fOADBForPHOS = kTRUE ; }
376  void SwitchOffPHOSOADB() { fOADBForPHOS = kFALSE ; }
377 
380 
381  //------------------------------
382  // Other settings
383  //------------------------------
384 
387 
392 
393 
394  void SetRunNumber(Int_t run) { fRunNumber = run ; }
395  Int_t GetRunNumber() const { return fRunNumber ; }
396 
397  private:
398 
400 
402 
404 
405  AliEMCALGeometry * fEMCALGeo ;
406 
407  AliPHOSGeoUtils * fPHOSGeo ;
408 
410 
412 
414 
415  TGeoHMatrix * fEMCALMatrix[22];
416 
418 
419  TGeoHMatrix * fPHOSMatrix[5];
420 
422 
424 
426 
428 
430  Int_t * fMaskCellColumns; //[fNMaskCellColumns]
431 
433 
435 
437 
439 
441 
443 
445 
447 
449 
451 
453 
455 
457 
459 
461 
463 
465 
467 
469 
471 
473 
477 
479 
481 
483 
486 
489 
491  ClassDef(AliCalorimeterUtils,20) ;
493 
494 } ;
495 
496 
497 #endif //ALICALORIMETERUTILS_H
498 
499 
500 
void SetCutEta(Float_t e)
void SetCutPhi(Float_t cutPhi)
Bool_t fRecalculatePosition
Recalculate cluster position.
Float_t GetCutZ() const
void SetNumberOfCellsFromPHOSBorder(Int_t n)
AliEMCALGeometry * fEMCALGeo
! EMCAL geometry pointer.
Bool_t IsL1PhaseInTimeRecalibrationOn() const
Bool_t IsMCParticleInCalorimeterAcceptance(Int_t calo, AliVParticle *particle)
Check that a MC AOD is in the calorimeter acceptance.
double Double_t
Definition: External.C:58
void InitPHOSRecalibrationFactors()
Init PHOS recalibration factors.
void SetRunNumber(Int_t run)
Bool_t IsRecalculationOfClusterTrackMatchingOn() const
TH2F * GetEMCALChannelRecalibrationFactors(Int_t iSM) const
Definition: External.C:236
TGeoHMatrix * fEMCALMatrix[22]
Geometry matrices with alignments.
Int_t GetPHOSChannelStatus(Int_t imod, Int_t iCol, Int_t iRow) const
void SetFirstSuperModuleUsed(Int_t first)
Float_t fLocMaxCutEDiff
Local maxima cut, when aggregating cells, next can be a bit higher.
Bool_t IsCorrectionOfClusterEnergyOn() const
Bool_t IsAbsIDsFromTCard(Int_t absId1, Int_t absId2, Int_t &rowDiff, Int_t &colDiff) const
void SetEMCALOADBFilePath(TString path)
TGeoHMatrix * fPHOSMatrix[5]
Geometry matrices with alignments.
Bool_t ClusterContainsBadChannel(Int_t calo, UShort_t *cellList, Int_t nCells)
Float_t GetEMCALChannelTimeRecalibrationFactor(Int_t bc, Int_t absID, Bool_t isLGon=kFALSE) const
void SwitchOnLoadOwnEMCALGeometryMatrices()
AliPHOSGeoUtils * fPHOSGeo
! PHOS geometry pointer.
TH2F * GetPHOSChannelRecalibrationFactors(Int_t imod) const
void SetNumberOfCellsFromEMCALBorder(Int_t n)
Int_t GetLastSuperModuleUsed() const
void SetImportGeometryFromFile(Bool_t import, TString path="")
AliEMCALRecoUtils * GetEMCALRecoUtils() const
void SetLastSuperModuleUsed(Int_t last)
Int_t GetEMCALL1PhaseInTimeRecalibrationForSM(Int_t iSM) const
Float_t GetECross(Int_t absId, AliVCaloCells *cells, Int_t bc)
TString EMCALGeometryName() const
void SetEMCALL1PhaseInTimeRecalibrationForAllSM(TObjArray *map)
void SwitchOnDistToBadChannelRecalculation()
void SwitchOffDistToBadChannelRecalculation()
void SwitchOnNoFiducialBorderInEMCALEta0()
void SwitchOnMCECellClusFracCorrection()
Float_t GetCutPhi() const
void SetEMCALChannelStatus(Int_t iSM, Int_t iCol, Int_t iRow, Double_t c=1)
void SetPHOSChannelRecalibrationFactors(Int_t imod, TH2F *h)
AliPHOSGeoUtils * GetPHOSGeometry() const
TH1C * GetEMCALL1PhaseInTimeRecalibrationForAllSM() const
Bool_t fOADBForEMCAL
Get calibration from OADB for EMCAL.
void SetEMCALL1PhaseInTimeRecalibrationForSM(Int_t iSM, Int_t c=0)
TString PHOSGeometryName() const
void SetEMCALChannelRecalibrationFactor(Int_t iSM, Int_t iCol, Int_t iRow, Double_t c=1)
Float_t GetPHOSChannelRecalibrationFactor(Int_t imod, Int_t iCol, Int_t iRow) const
void SetEMCALChannelTimeRecalibrationFactors(Int_t bc, TH1F *h)
void SwitchOffRecalculateClusterPosition()
void SwitchOffDistToBadChannelRecalculation()
Bool_t ClusterContainsBadChannel(TString, UShort_t *, Int_t)
Float_t fLocMaxCutE
Local maxima cut must have more than this energy.
Float_t GetMCECellClusFracCorrection(Float_t eCell, Float_t eCluster) const
void RecalculateClusterDistanceToBadChannel(AliVCaloCells *cells, AliVCluster *clu)
Bool_t CheckCellFiducialRegion(AliVCluster *cluster, AliVCaloCells *cells, AliVEvent *, Int_t)
void SetEMCALChannelStatusMap(Int_t iSM, TH2I *h)
Int_t GetNumberOfCellsFromEMCALBorder() const
Bool_t fRunDependentCorrection
Switch on or off the recalibration dependent on T.
TCanvas * c
Definition: TestFitELoss.C:172
void SetLocalMaximaCutEDiff(Float_t c)
void SetNumberOfCellsFromEMCALBorder(Int_t n)
TObjArray * fPHOSRecalibrationFactors
Array of histograms with map of recalibration factors, PHOS.
void SwitchOffNoFiducialBorderInEMCALEta0()
TString fEMCALGeoName
Name of geometry to use for EMCAL.
void SetEMCALL1PhaseInTimeRecalibrationForAllSM(TH1C *h)
TH2F * GetEMCALChannelRecalibrationFactors(Int_t iSM) const
void SetPHOSChannelStatus(Int_t imod, Int_t iCol, Int_t iRow, Double_t c=1)
Bool_t fRecalibration
Switch on or off the recalibration.
Float_t GetEMCALChannelRecalibrationFactor(Int_t iSM, Int_t iCol, Int_t iRow) const
TH1F * GetEMCALChannelTimeRecalibrationFactors(Int_t bc) const
Bool_t IsDistanceToBadChannelRecalculated() const
void SwitchOnLoadOwnPHOSGeometryMatrices()
Int_t fDebug
Debugging level.
TH1C * GetEMCALL1PhaseInTimeRecalibrationForAllSM() const
Int_t GetNumberOfCellsFromPHOSBorder() const
Bool_t IsRecalibrationOn() const
void SetMCECellClusFracCorrectionParamters(Int_t i, Float_t param)
Some utilities for cluster and cell treatment.
void SetPHOSGeometryName(TString name)
virtual void Print(const Option_t *opt) const
Print some relevant parameters set for the analysis.
void SetMaskCellColumn(Int_t ipos, Int_t icol)
void RecalculateClusterPID(AliVCluster *clu)
Float_t GetEMCALChannelTimeRecalibrationFactor(Int_t bc, Int_t absID) const
void RecalculateClusterDistanceToBadChannel(const AliEMCALGeometry *geom, AliVCaloCells *cells, AliVCluster *cluster)
void SwitchOffRecalculateClusterTrackMatching()
TH2I * GetEMCALChannelStatusMap(Int_t iSM) const
Float_t fCutEta
dEta cut on matching (EMCAL).
Float_t GetLocalMaximaCutE() const
Int_t GetModuleNumber(AliCaloTrackParticle *particle, AliVEvent *inputEvent) const
Get the EMCAL/PHOS module number that corresponds to this particle.
void SetCutPhi(Float_t p)
Float_t GetEMCALChannelRecalibrationFactor(Int_t iSM, Int_t iCol, Int_t iRow) const
Bool_t fLoadEMCALMatrices
Matrices set from configuration, not get from geometry.root or from ESDs/AODs.
virtual void SetDebug(Int_t d)
AliEMCALGeometry * GetEMCALGeometry() const
void SwitchOnL1PhaseInTimeRecalibration()
int Int_t
Definition: External.C:63
void RecalculateClusterShowerShapeParameters(AliVCaloCells *cells, AliVCluster *clu)
void SwitchOffMCECellClusFracCorrection()
Container for input particle information on CaloTrackCorr package.
void SetNMaskCellColumns(Int_t n)
Float_t GetLocalMaximaCutEDiff() const
Bool_t IsL1PhaseInTimeRecalibrationOn() const
Bool_t fRecalculateMatching
Recalculate cluster position.
Bool_t IsEMCALNoBorderAtEta0() const
Bool_t GetEMCALChannelStatus(Int_t iSM, Int_t iCol, Int_t iRow, Int_t &status) const
Bool_t MaskFrameCluster(Int_t iSM, Int_t ieta) const
void RecalculateClusterShowerShapeParameters(const AliEMCALGeometry *geom, AliVCaloCells *cells, AliVCluster *cluster)
float Float_t
Definition: External.C:68
AliCalorimeterUtils & operator=(const AliCalorimeterUtils &cu)
Assignment operator not implemented.
Bool_t fOADBForPHOS
Get calibration from OADB for PHOS.
Bool_t IsBadChannelsRemovalSwitchedOn() const
Int_t * fMaskCellColumns
List of masked cells collumn index.
Bool_t fRemoveBadChannels
Check the channel status provided and remove clusters with bad channels.
void InitPHOSBadChannelStatusMap()
Init PHOS bad channels map.
virtual Int_t GetDebug() const
Int_t GetRunNumber() const
void RecalculateClusterTrackMatching(AliVEvent *event, TObjArray *clusterArray=0x0, AliMCEvent *mc=0x0)
Bool_t IsTimeRecalibrationOn() const
AliCalorimeterUtils()
Constructor. Initialize parameters.
void SetEMCALChannelTimeRecalibrationFactor(Int_t bc, Int_t absID, Double_t c=0)
virtual void InitParameters()
Initialize the parameters of the analysis.
void SwitchOnRecalculateClusterTrackMatching()
void SetEMCALChannelRecalibrationFactors(TObjArray *map)
Int_t fNMaskCellColumns
Number of masked columns.
Float_t GetCutR() const
Bool_t IsMCECellClusFracCorrectionOn() const
Int_t fLastSuperModuleUsed
Number of last supermodule to be used in analysis, to activate only certain range (DCal or EMCal) ...
void SetPHOSGeometryMatrixInSM(TGeoHMatrix *m, Int_t i)
Int_t GetNumberOfSuperModulesUsed() const
void SwitchOffBadChannelsRemoval()
Bool_t IsEMCALNoBorderAtEta0() const
Bool_t IsClusterSharedByTwoSuperModules(const AliEMCALGeometry *geom, AliVCluster *cluster)
Int_t fFirstSuperModuleUsed
Number of first supermodule to be used in analysis, to activate only certain range (DCal or EMCal) ...
void GetMatchedResiduals(Int_t clsIndex, Float_t &dEta, Float_t &dPhi)
Bool_t IsRecalculationOfClusterPositionOn() const
Float_t fMCECellClusFracCorrParam[4]
Parameters for the function correcting the weight of the cells in the cluster.
Int_t GetNumberOfLocalMaxima(AliVCluster *cluster, AliVCaloCells *cells)
Find the number of local maxima in cluster.
Bool_t fEMCALGeoMatrixSet
Check if the transformation matrix is set for EMCAL.
void SetEMCALGeometryName(TString name)
void SetPHOSOADBFilePath(TString path)
void SetNumberOfSuperModulesUsed(Int_t nSM)
void SwitchOffNoFiducialBorderInEMCALEta0()
void SwitchOffL1PhaseInTimeRecalibration()
TH2I * GetPHOSChannelStatusMap(Int_t imod) const
void SetEMCALChannelRecalibrationFactor(Int_t iSM, Int_t iCol, Int_t iRow, Double_t c=1)
Float_t GetCutEta() const
TString GetPass()
Get passx from filename.
void SetCutR(Float_t cutR)
void RecalculateClusterPosition(AliVCaloCells *cells, AliVCluster *clu)
void SwitchOnDistToBadChannelRecalculation()
Bool_t fImportGeometryFromFile
Import geometry settings in geometry.root file.
Int_t GetNMaskCellColumns() const
Bool_t fCorrectELinearity
Correct cluster energy linearity.
Bool_t fPHOSGeoMatrixSet
Check if the transformation matrix is set for PHOS.
TString fOADBFilePathPHOS
Default path $ALICE_PHYSICS/OADB/PHOS, if needed change.
void SwitchOnNoFiducialBorderInEMCALEta0()
void CorrectClusterEnergy(AliVCluster *cl)
Correct cluster energy non linearity.
void SetEMCALGeometryMatrixInSM(TGeoHMatrix *m, Int_t i)
void GetMatchedResiduals(Int_t index, Float_t &dR, Float_t &dZ)
Float_t fCutZ
dZ cut on matching (EMCAL/PHOS).
Bool_t fLoadPHOSMatrices
Matrices set from configuration, not get from geometry.root or from ESDs/AODs.
void SetPHOSChannelStatusMap(Int_t imod, TH2I *h)
Int_t fNCellsFromPHOSBorder
Number of cells from PHOS border the cell with maximum amplitude has to be.
void RecalculateClusterPID(AliVCluster *cluster)
AliVTrack * GetMatchedTrack(AliVCluster *cluster, AliVEvent *event, Int_t index=-1) const
void RecalibrateCellTimeL1Phase(Double_t &time, Int_t calo, Int_t iSM, Int_t bunchCrossNumber) const
Recalculate time L1 phase shift if time recalibration available for EMCAL.
Bool_t fMCECellClusFracCorrOn
Correct or not the weight of cells in cluster.
void SetEMCALL1PhaseInTimeRecalibrationForAllSM(const TObjArray *map)
void SetPHOSChannelStatusMap(TObjArray *map)
Int_t fNSuperModulesUsed
Number of supermodules to be used in analysis, can be different than the real geo, to be used at initialization of histograms.
TString fImportGeometryFilePath
Path fo geometry.root file.
Bool_t fPlotCluster
Plot cluster in splitting method.
Int_t fRunNumber
Run number of the data, take it from data itself unless set by user.
void SwitchOffLoadOwnPHOSGeometryMatrices()
void RecalibrateCellAmplitude(Float_t &amp, Int_t calo, Int_t absId) const
Recalculate cell energy if recalibration factor.
void SetEMCALChannelTimeRecalibrationFactors(TObjArray *map)
Bool_t IsPHOSGeoMatrixSet() const
void SwitchOffLoadOwnEMCALGeometryMatrices()
void SetEMCALChannelStatusMap(TObjArray *map)
Bool_t IsTimeRecalibrationOn() const
Bool_t IsDistanceToBadChannelRecalculated() const
Bool_t fOADBSet
AODB parameters already set.
unsigned short UShort_t
Definition: External.C:28
void SetEMCALChannelTimeRecalibrationFactors(const TObjArray *map)
TObjArray * fPHOSBadChannelMap
Array of histograms with map of bad channels, PHOS.
TString fPHOSGeoName
Name of geometry to use for PHOS.
Bool_t AreNeighbours(Int_t calo, Int_t absId1, Int_t absId2) const
const char Option_t
Definition: External.C:48
void ConfigureEMCALRecoUtils(Bool_t bMC=kFALSE, Bool_t bExotic=kTRUE, Bool_t bNonLin=kFALSE, Bool_t bRecalE=kTRUE, Bool_t bBad=kTRUE, Bool_t bRecalT=kTRUE, Int_t debug=-1)
Float_t fCutPhi
dPhi cut on matching (EMCAL).
void SetEMCALChannelTimeRecalibrationFactor(Int_t bc, Int_t absID, Double_t c=0, Bool_t isLGon=kFALSE)
Int_t GetEMCALL1PhaseInTimeRecalibrationForSM(Int_t iSM) const
void SetEMCALChannelStatus(Int_t iSM, Int_t iCol, Int_t iRow, Double_t status=1)
bool Bool_t
Definition: External.C:53
Bool_t IsEMCALGeoMatrixSet() const
Class with utils specific to calorimeter clusters/cells.
Int_t GetNumberOfCellsFromEMCALBorder() const
void AccessGeometry(AliVEvent *inputEvent)
void SetCutEta(Float_t cutEta)
void SetPHOSChannelRecalibrationFactors(TObjArray *map)
void SetEMCALRecoUtils(AliEMCALRecoUtils *ru)
AliEMCALRecoUtils * fEMCALRecoUtils
EMCAL utils for cluster rereconstruction.
Int_t GetFirstSuperModuleUsed() const
void SetEMCALL1PhaseInTimeRecalibrationForSM(Int_t iSM, Int_t c=0)
void SetEMCALChannelRecalibrationFactors(Int_t iSM, TH2F *h)
void AccessOADB(AliVEvent *event)
void SetEMCALChannelRecalibrationFactors(const TObjArray *map)
TString fOADBFilePathEMCAL
Default path $ALICE_PHYSICS/OADB/EMCAL, if needed change.
void RecalibrateCellTime(Double_t &time, Int_t calo, Int_t absId, Int_t bunchCrossNumber) const
Recalculate time if time recalibration available for EMCAL not ready for PHOS.
Int_t GetMaxEnergyCell(AliVCaloCells *cells, AliVCluster *clu, Float_t &fraction) const
For a given CaloCluster, it gets the absId of the cell with maximum energy deposit.
Float_t fCutR
dR cut on matching (PHOS).
void SwitchOffL1PhaseInTimeRecalibration()
void SetEMCALChannelStatusMap(const TObjArray *map)
Int_t GetEMCALChannelStatus(Int_t iSM, Int_t iCol, Int_t iRow, Int_t status) const
void SetLocalMaximaCutE(Float_t cut)
Float_t RecalibrateClusterEnergyWeightCell(AliVCluster *cluster, AliVCaloCells *cells, Float_t energyOrg)
void SplitEnergy(Int_t absId1, Int_t absId2, AliVCluster *cluster, AliVCaloCells *cells, AliAODCaloCluster *cluster1, AliAODCaloCluster *cluster2, Int_t nMax, Int_t eventNumber=0)
Bool_t GetFECCorrelatedCellAbsId(Int_t absId, Int_t absIdCorr[4]) const
Int_t GetModuleNumberCellIndexes(Int_t absId, Int_t calo, Int_t &icol, Int_t &irow, Int_t &iRCU) const
Get the EMCAL/PHOS module, columns, row and RCU/DDL number that corresponds to this absId...
TH2I * GetEMCALChannelStatusMap(Int_t iSM) const
void SetPHOSChannelRecalibrationFactor(Int_t imod, Int_t iCol, Int_t iRow, Double_t c=1)
Float_t RecalibrateClusterEnergy(AliVCluster *cluster, AliVCaloCells *cells)
Recalibrate the cluster energy, considering the recalibration map and the energy of the cells that co...
void GetEMCALSubregion(AliVCluster *clus, AliVCaloCells *cells, Int_t &regEta, Int_t &regPhi) const
Bool_t CheckCellFiducialRegion(AliVCluster *cluster, AliVCaloCells *cells) const
Int_t GetModuleNumberCellIndexesAbsCaloMap(Int_t absId, Int_t calo, Int_t &icol, Int_t &irow, Int_t &iRCU, Int_t &icolAbs, Int_t &irowAbs) const