Belle II Software  release-05-02-19
arich modules
Collaboration diagram for arich modules:

Classes

class  arichBtestModule
 The UserTutorial module. More...
 
class  ARICHChannelMaskModule
 Testing module for collection of calibration data. More...
 
class  ARICHDigitizerModule
 ARICH digitizer module. More...
 
class  ARICHDQMModule
 Make summary of data quality from reconstruction. More...
 
class  ARICHFillHitsModule
 Fill ARICHHit collection from ARICHDigits. More...
 
class  ARICHMCParticlesModule
 
class  ARICHNtupleModule
 ARICH reconstruction efficiency test module. More...
 
class  ARICHPackerModule
 Raw data packer for ARICH. More...
 
class  ARICHRateCalModule
 Fill ARICHHit collection from ARICHDigits. More...
 
class  ARICHRawUnpackerModule
 Fill ARICHHit collection from ARICHDigits. More...
 
class  ARICHReconstruction
 Internal ARICH track reconstruction. More...
 
class  ARICHReconstructorModule
 ARICH subdetector main module. More...
 
class  ARICHRelateModule
 
class  arichToNtupleModule
 This module extends existing variablesToNtuple to append detailed arich information to candidates in the analysis output ntuple. More...
 
struct  ARICHRawHeader
 
class  ARICHUnpackerModule
 Raw data unpacker for ARICH. More...
 

Macros

#define ARICH_BUFFER_NWORDS   252
 
#define ARICHFEB_HEADER_SIZE   10
 
#define ARICHRAW_HEADER_SIZE   12
 

Functions

TH2 * moduleHitMap (TH1 *hitMap, int moduleID)
 Make hit map in HAPD view (12*12 channels) More...
 
TH2 * moduleDeadMap (TH1 *hitMap, int moduleID)
 Make chip dead/alive map in HAPD view (2*2 chips) More...
 
TH1 * mergerClusterHitMap1D (TH1 *hitMap, int mergerID)
 Make 1D hit map of specified Merger Board. More...
 
TCanvas * mergerClusterHitMap2D (TH1 *hitMap, int mergerID)
 Make display of 6 HAPDs' 2D hit map of the Merger Board. More...
 
TCanvas * sectorHitMap (TH1 *hitMap, int sector)
 Make display of 70 HAPDs' 2D hit map of the sector. More...
 
TCanvas * sectorDeadMap (TH1 *hitMap, int sector)
 Make display of 70 HAPDs' 2D dead/alive map of the sector. More...
 
 REG_MODULE (ARICHDQM)
 
void deadPalette ()
 
 REG_MODULE (ARICHRateCal)
 
 REG_MODULE (ARICHRawUnpacker)
 
 arichBtestModule ()
 Constructor. More...
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
int skipdata (gzFile fp)
 Skip the data part of the record.
 
void readmwpc (unsigned int *dbuf, unsigned int len, int print=0)
 Read the MWPC information from the data buffer.
 
int readhapd (unsigned int len, unsigned int *data)
 Read the HAPD hits from the data buffer.
 
int getTrack (int mask, TVector3 &r, TVector3 &dir)
 Beamtest Track reconstruction.
 
int readdata (gzFile fp, int rec_id, int print)
 Read the data from the file (can be compressed)
 
virtual void event () override
 Running over all events. More...
 
virtual void endRun () override
 Is called after processing the last event of a run. More...
 
virtual void terminate () override
 Is called at the end of your Module. More...
 
 ARICHDigitizerModule ()
 Constructor.
 
virtual ~ARICHDigitizerModule ()
 Destructor.
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor. More...
 
void magFieldDistorsion (TVector2 &hit, int copyno)
 Apply correction to hit position due to non-perpendicular component of magnetic field. More...
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
 ARICHDQMModule ()
 Constructor.
 
virtual ~ARICHDQMModule ()
 Destructor.
 
virtual void defineHisto () override
 Function to define histograms. More...
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor.
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
 ARICHFillHitsModule ()
 Constructor.
 
virtual ~ARICHFillHitsModule ()
 Destructor.
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor.
 
void magFieldCorrection (TVector3 &hitpos)
 Corrects hit position for distorsion due to non-perpendicular magnetic field component.
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
 ARICHMCParticlesModule ()
 Constructor.
 
virtual ~ARICHMCParticlesModule ()
 Destructor.
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor.
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
void printModuleParams () const
 Prints module parameters.
 
 ARICHNtupleModule ()
 Constructor.
 
virtual ~ARICHNtupleModule ()
 Destructor.
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor.
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
 ARICHPackerModule ()
 Constructor.
 
virtual ~ARICHPackerModule ()
 Destructor.
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor.
 
void writeHeader (int *buffer, unsigned &ibyte, const ARICHRawHeader &head)
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
unsigned int calbyte (const int *buf)
 
unsigned int calword (const int *buf)
 
 ARICHRateCalModule ()
 Constructor.
 
virtual ~ARICHRateCalModule ()
 Destructor.
 
virtual void defineHisto () override
 Function to define histograms. More...
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor.
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
unsigned int calbyte (const int *buf)
 
unsigned int calword (const int *buf)
 
 ARICHRawUnpackerModule ()
 Constructor.
 
virtual ~ARICHRawUnpackerModule ()
 Destructor.
 
virtual void defineHisto () override
 Function to define histograms. More...
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor.
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
 ARICHReconstruction (int storePhotons=0)
 Constructor.
 
void initialize ()
 read geomerty parameters from xml and initialize class memebers
 
int InsideDetector (TVector3 a, int copyno)
 Returns 1 if vector "a" lies on "copyno"-th detector active surface of detector and 0 else.
 
int smearTrack (ARICHTrack &arichTrack)
 Smeares track parameters ("simulate" the uncertainties of tracking).
 
TVector3 FastTracking (TVector3 dirf, TVector3 r, double *refind, double *z, int n, int opt)
 Calculates the intersection of the Cherenkov photon emitted from point "r" in "dirf" direction with the detector plane. More...
 
TVector3 HitVirtualPosition (const TVector3 &hitpos, int mirrorID)
 Returns the hit virtual position, assuming that it was reflected from mirror. More...
 
bool HitsMirror (const TVector3 &pos, const TVector3 &dir, int mirrorID)
 returns true if photon at position pos with direction dir hits mirror plate with ID mirrorID
 
int CherenkovPhoton (TVector3 r, TVector3 rh, TVector3 &rf, TVector3 &dirf, double *refind, double *z, int n, int mirrorID=0)
 Calculates the direction of photon emission. More...
 
int likelihood2 (ARICHTrack &arichTrack, const StoreArray< ARICHHit > &arichHits, ARICHLikelihood &arichLikelihood)
 Computes the value of identity likelihood function for different particle hypotheses.
 
void setTrackPositionResolution (double pRes)
 Sets track position resolution (from tracking)
 
void setTrackAngleResolution (double aRes)
 Sets track direction resolution (from tracking)
 
TVector3 getTrackMeanEmissionPosition (const ARICHTrack &track, int iAero)
 Returns mean emission position of Cherenkov photons from i-th aerogel layer.
 
TVector3 getTrackPositionAtZ (const ARICHTrack &track, double zout)
 Returns track direction at point with z coordinate "zout" (assumes straight track).
 
void transformTrackToLocal (ARICHTrack &arichTrack, bool align)
 Transforms track parameters from global Belle2 to ARICH local frame.
 
TVector3 getMirrorPoint (int mirrorID)
 Returns point on the mirror plate with id mirrorID.
 
TVector3 getMirrorNorm (int mirrorID)
 Returns normal vector of the mirror plate with id mirrorID.
 
void correctEmissionPoint (int tileID, double r)
 correct mean emission point z position
 
 ARICHReconstructorModule ()
 Constructor.
 
virtual ~ARICHReconstructorModule ()
 Destructor.
 
virtual void initialize () override
 Initialize the Module.
 
virtual void beginRun () override
 Called when entering a new run.
 
virtual void event () override
 Event processor.
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
void printModuleParams ()
 Print module parameters.
 
 ARICHRelateModule ()
 Constructor.
 
virtual ~ARICHRelateModule ()
 Destructor.
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor.
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 
void printModuleParams () const
 Prints module parameters.
 
unsigned int calbyte (const int *buf)
 calculate number of bytes in raw Unpacker
 
unsigned int cal2byte (const int *buf)
 calculate number of lines (2 bytes) in raw Unpacker
 
unsigned int calword (const int *buf)
 calculate number of words in raw Unpacker
 
 ARICHUnpackerModule ()
 Constructor.
 
virtual ~ARICHUnpackerModule ()
 Destructor.
 
virtual void initialize () override
 Initialize the Module. More...
 
virtual void beginRun () override
 Called when entering a new run. More...
 
virtual void event () override
 Event processor. More...
 
void readHeader (const int *buffer, unsigned &ibyte, ARICHRawHeader &head)
 
void readFEHeader (const int *buffer, unsigned &ibyte, ARICHRawHeader &head)
 read Merger header
 
void printBits (const int *buffer, int bufferSize)
 Unpack raw data given in production format. More...
 
virtual void endRun () override
 End-of-run action. More...
 
virtual void terminate () override
 Termination action. More...
 

Variables

TNtuple * m_tuple
 ntuple containing hapd hits
 
TH1F * hapd [6]
 histogram of hits for each hapd
 
TH1F * mwpc_tdc [4][5]
 tdc information from mwpcs
 
TH1F * mwpc_diff [4][2]
 tdc difference from mwpcs
 
TH1F * mwpc_sum [4][2]
 tdc sum from mwpcs
 
TH1F * mwpc_sum_cut [4][2]
 tdc sum from mwpcs, with sum cut applied
 
TH1F * mwpc_residuals [4][2]
 residuals from mwpcs
 
TH2F * mwpc_xy [4]
 calculated x-y track positions
 
TH2F * mwpc_residualsz [4][2]
 z-residuals from mwpcs
 

Detailed Description

Function Documentation

◆ arichBtestModule()

Constructor.

Sets the module parameters.

Definition at line 67 of file arichBtestModule.cc.

67  : Module(), m_end(0), m_events(0), m_file(NULL), m_timestart(0), m_mwpc(NULL)
68  {
69  //Set module properties
70  setDescription("Module for the ARICH Beamtest data analysis. It creates track form the MWPC hits and reads the HAPD hits");
71 
72  //Parameter definition
73  addParam("outputFileName", m_outFile, "Output Root Filename", string("output.root"));
74  vector<string> defaultList;
75  addParam("runList", m_runList, "Data Filenames.", defaultList);
76  vector<int> defaultMask;
77  addParam("mwpcTrackMask", m_MwpcTrackMask, "Create track from MWPC layers", defaultMask);
78  m_fp = NULL;
79  addParam("beamMomentum", m_beamMomentum, "Momentum of the beam [GeV]", 0.0);
80 
81  for (int i = 0; i < 32; i++) m_tdc[i] = 0;
82 
83  }

◆ beginRun() [1/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

At the beginning of each run, the function gives you the chance to change run dependent constants like alignment parameters, etc.

Reimplemented from Module.

Definition at line 153 of file arichBtestModule.cc.

◆ beginRun() [2/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from HistoModule.

Definition at line 67 of file ARICHRawUnpackerModule.cc.

68  {
69  }

◆ beginRun() [3/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from HistoModule.

Definition at line 108 of file ARICHRateCalModule.cc.

109  {
110  StoreObjPtr<EventMetaData> evtmetadata;
111  //int expno = evtmetadata->getExperiment();
112  int runno = evtmetadata->getRun();
113  if (runno == 100 && !m_internalmode) {
114  terminate();
115  }
116  }

◆ beginRun() [4/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from Module.

Definition at line 65 of file ARICHMCParticlesModule.cc.

66  {
67  }

◆ beginRun() [5/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from Module.

Definition at line 94 of file ARICHUnpackerModule.cc.

95  {
96  }

◆ beginRun() [6/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from Module.

Definition at line 63 of file ARICHRelateModule.cc.

64  {
65  }

◆ beginRun() [7/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from Module.

Definition at line 76 of file ARICHPackerModule.cc.

77  {
78  }

◆ beginRun() [8/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from Module.

Definition at line 73 of file ARICHFillHitsModule.cc.

74  {
75  }

◆ beginRun() [9/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from HistoModule.

Definition at line 227 of file ARICHDQMModule.cc.

228  {
229 
230  h_chStat->Reset();
231  h_aeroStat->Reset();
232  h_chDigit->Reset();
233  h_chipDigit->Reset();
234  h_hapdDigit->Reset();
235 
236  h_chHit->Reset();
237  h_chipHit->Reset();
238  h_hapdHit->Reset();
239  h_mergerHit->Reset();
240  h_bitsPerMergerNorm->Reset();
241  h_bitsPerHapdMerger->Reset();
242 
243  h_aerogelHit->Reset();
244  h_bits->Reset();
245  h_bitsPerChannel->Reset();
246  h_hitsPerTrack2D->Reset();
247  h_tracks2D->Reset();
248  h_aerogelHits3D->Reset();
249 
250  h_hitsPerEvent->Reset();
251  h_theta->Reset();
252  h_hitsPerTrack->Reset();
253  h_trackPerEvent->Reset();
254  h_flashPerAPD->Reset();
255  h_mirrorThetaPhi->Reset();
256  h_thetaPhi->Reset();
257 
258  for (int i = 0; i < 6; i++) {
259  h_secTheta[i]->Reset();
260  h_secHitsPerTrack[i]->Reset();
261  }
262 
263  h_ARICHOccAfterInjLer->Reset();
264  h_ARICHEOccAfterInjLer->Reset();
265  h_ARICHOccAfterInjHer->Reset();
266  h_ARICHEOccAfterInjHer->Reset();
267  }

◆ beginRun() [10/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from Module.

Definition at line 95 of file ARICHDigitizerModule.cc.

96  {
97  if (m_simPar->getNBkgHits() > 0) m_bkgLevel = m_simPar->getNBkgHits();
98  }

◆ beginRun() [11/11]

void beginRun ( )
overridevirtual

Called when entering a new run.

Set run dependent things like run header parameters, alignment, etc.

Reimplemented from Module.

Definition at line 145 of file ARICHNtupleModule.cc.

146  {
147  }

◆ CherenkovPhoton()

int CherenkovPhoton ( TVector3  r,
TVector3  rh,
TVector3 &  rf,
TVector3 &  dirf,
double *  refind,
double *  z,
int  n,
int  mirrorID = 0 
)
private

Calculates the direction of photon emission.

Giving the Cherenkov photon emission point "r" and its position on detector plane "rh" (hit position) this methods calculates the direction "dirf" in which photon was emitted, under the assumption that it was reflected from "nmir"-th mirror plate (nmir=-1 for no reflection).

Parameters
rvector of photon emission point
rhphoton hit position
dirfvector of photon emission direction (this is output of method)
rfvector of photon position on aerogel exit
refindarray of layers refractive indices
nnumber of aerogel layers through which photon passes
zarray of z coordinates of borders between layers
nmirid of mirror from which the foton was reflected (assuming).

Definition at line 253 of file ARICHReconstruction.cc.

256  {
257  //
258  // Description:
259  // The method calculates the direction of the cherenkov photon
260  // and intersection with the aerogel exit point
261  //
262  // Called by: CerenkovAngle
263 
264 
265  // Arguments:
266  // Input:
267  // dir, r track position
268  // rh photon hit
269 
270 
271  // Output:
272  // rf aerogel exit from which the photon was emitted
273  // dirf photon direction in aerogel
274  static TVector3 norm(0, 0, 1); // detector plane normal vector
275 
276  double dwin = m_arichgp->getHAPDGeometry().getWinThickness();
277  double refractiveInd0 = m_arichgp->getHAPDGeometry().getWinRefIndex();
278 
279  // iteration is stoped when the difference of photon positions on first aerogel exit
280  // between two iterations is smaller than this value.
281  const double dmin = 0.0000001;
282  const int niter = 100; // maximal number of iterations
283  TVector3 dirw;
284  TVector3 rh1 = rh - dwin * norm;
285 
286  std::vector <TVector3> rf0(n + 2);
287  // rf0[0] .. track point
288  // rf0[1] 1. 1st aerogel exit
289  // rf0[n] n. aerogel exit ...
290  std::vector <TVector3> dirf0(n + 2);
291  // dirf0[0] .. 1st aerogel direction
292  // dirf0[1] .. 2nd aerogel direction
293  // dirf0[n] .. direction after aerogels
294 
295  // z[0] .. 1st aerogel exit
296  // z[n-1] .. 2nd aerogel exit
297  // z[n] .. detector position
298  // z[n+1] .. detector + window
299 
300  rf0[0] = r;
301  rf0[1] = rf;
302 
303  for (int iter = 0; iter < niter; iter++) {
304 
305  // direction in the space between aerogels and detector
306  // *************************************
307  if (iter == 0) dirf0[n] = (rh1 - rf0[1]).Unit();
308  else dirf0[n] = (rh1 - rf0[n]).Unit();
309 
310  // *************************************
311  // n-layers of aerogel // refractiveInd relative refractive index
312  for (int a = n - 1; a >= 0 ; a--) {
313  double rind = refractiveInd[a] / refractiveInd[a + 1];
314  dirf0[a] = Refraction(dirf0[a + 1], rind);
315  }
316 
317  double path = (z[0] - r.z()) / dirf0[0].z();
318  double x1 = rf0[1].x();
319  double y1 = rf0[1].y();
320  for (int a = 0; a < n ; a++) {
321  rf0[a + 1] = rf0[a] + dirf0[a] * path;
322  path = (z[a + 1] - rf0[a + 1].z()) / dirf0[a + 1].z();
323  }
324 
325  Refraction(dirf0[n], norm, refractiveInd0, dirw);
326 
327  // *************************************
328 
329  path = dwin / (dirw * norm);
330  rh1 = rh - dirw * path;
331 
332  double d2 = (rf0[1].x() - x1) * (rf0[1].x() - x1) + (rf0[1].y() - y1) * (rf0[1].y() - y1);
333 
334  if ((d2 < dmin) && (iter)) {
335 
336  // if mirror hypothesis check if reflection point lies on mirror plate
337  if (mirrorID) {
338  if (!HitsMirror(rf0[n], dirf0[n], mirrorID)) return -1;
339  }
340 
341  rf = rf0[1];
342  dirf = dirf0[0];
343  return iter;
344  }
345  }
346  return -1;
347  }

◆ defineHisto() [1/3]

void defineHisto ( )
overridevirtual

Function to define histograms.

This function is hooked to HistoManager by calling RbTupleManager::Instance().register_module ( this ) or using a macro REG_HISTOGRAM. It is supposed to be done in initialize() function.

Reimplemented from HistoModule.

Definition at line 50 of file ARICHRawUnpackerModule.cc.

◆ defineHisto() [2/3]

void defineHisto ( )
overridevirtual

Function to define histograms.

This function is hooked to HistoManager by calling RbTupleManager::Instance().register_module ( this ) or using a macro REG_HISTOGRAM. It is supposed to be done in initialize() function.

Reimplemented from HistoModule.

Definition at line 69 of file ARICHRateCalModule.cc.

◆ defineHisto() [3/3]

void defineHisto ( )
overridevirtual

Function to define histograms.

This function is hooked to HistoManager by calling RbTupleManager::Instance().register_module ( this ) or using a macro REG_HISTOGRAM. It is supposed to be done in initialize() function.

Reimplemented from HistoModule.

Definition at line 73 of file ARICHDQMModule.cc.

◆ endRun() [1/12]

void endRun ( )
overridevirtual

Is called after processing the last event of a run.

Good e.g. for storing stuff, that you want to aggregate over one run.

Reimplemented from Module.

Definition at line 559 of file arichBtestModule.cc.

◆ endRun() [2/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from HistoModule.

Definition at line 167 of file ARICHRawUnpackerModule.cc.

◆ endRun() [3/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from HistoModule.

Definition at line 160 of file ARICHRateCalModule.cc.

◆ endRun() [4/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from Module.

Definition at line 108 of file ARICHMCParticlesModule.cc.

◆ endRun() [5/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from Module.

Definition at line 524 of file ARICHUnpackerModule.cc.

◆ endRun() [6/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from Module.

Definition at line 104 of file ARICHRelateModule.cc.

◆ endRun() [7/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from Module.

Definition at line 257 of file ARICHPackerModule.cc.

◆ endRun() [8/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from HistoModule.

Definition at line 459 of file ARICHDQMModule.cc.

◆ endRun() [9/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from Module.

Definition at line 236 of file ARICHReconstructorModule.cc.

237  {
238  }

◆ endRun() [10/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from Module.

Definition at line 169 of file ARICHFillHitsModule.cc.

◆ endRun() [11/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from Module.

Definition at line 230 of file ARICHDigitizerModule.cc.

◆ endRun() [12/12]

void endRun ( )
overridevirtual

End-of-run action.

Save run-related stuff, such as statistics.

Reimplemented from Module.

Definition at line 351 of file ARICHNtupleModule.cc.

◆ event() [1/3]

void event ( )
overridevirtual

Running over all events.

Function is called for each evRunning over all events This means, this function is called very often, and good performance of the code is of strong interest.

Reimplemented from Module.

Definition at line 470 of file arichBtestModule.cc.

◆ event() [2/3]

void event ( )
overridevirtual

Event processor.

temporary! FEB Slots on merger should be 1-6 (now 0-5). Remove when firmware is updated!

Reimplemented from Module.

Definition at line 98 of file ARICHUnpackerModule.cc.

◆ event() [3/3]

void event ( )
overridevirtual

Event processor.

Convert ARICHSimHits of the event to arichDigits.

Reimplemented from Module.

Definition at line 100 of file ARICHDigitizerModule.cc.

◆ FastTracking()

TVector3 FastTracking ( TVector3  dirf,
TVector3  r,
double *  refind,
double *  z,
int  n,
int  opt 
)
private

Calculates the intersection of the Cherenkov photon emitted from point "r" in "dirf" direction with the detector plane.

Parameters
rvector of photon emission point
dirfdirection of photon emission
nnumber of aerogel layers through which photon passes
refindarray of layers refractive indices
zarray of z coordinates of borders between layers

Definition at line 152 of file ARICHReconstruction.cc.

◆ HitVirtualPosition()

TVector3 HitVirtualPosition ( const TVector3 &  hitpos,
int  mirrorID 
)
private

Returns the hit virtual position, assuming that it was reflected from mirror.

Parameters
hitposvector of hit position
mirrorIDid of mirror from which the photon was reflected

Definition at line 226 of file ARICHReconstruction.cc.

◆ initialize() [1/11]

void initialize ( )
overridevirtual

Initialize the Module.

Function is called only once at the beginning of your job at the beginning of the corresponding module. Things that can be done here, should be done here, as it is relatively cheap in terms of CPU time.

Reimplemented from Module.

Definition at line 97 of file arichBtestModule.cc.

◆ initialize() [2/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from HistoModule.

Definition at line 58 of file ARICHRawUnpackerModule.cc.

◆ initialize() [3/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from HistoModule.

Definition at line 98 of file ARICHRateCalModule.cc.

◆ initialize() [4/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from Module.

Definition at line 53 of file ARICHMCParticlesModule.cc.

◆ initialize() [5/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from Module.

Definition at line 77 of file ARICHUnpackerModule.cc.

◆ initialize() [6/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

better use isRequired(), but RawFTSW is not in sim

Reimplemented from HistoModule.

Definition at line 207 of file ARICHDQMModule.cc.

◆ initialize() [7/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from Module.

Definition at line 52 of file ARICHRelateModule.cc.

◆ initialize() [8/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from Module.

Definition at line 76 of file ARICHDigitizerModule.cc.

◆ initialize() [9/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from Module.

Definition at line 61 of file ARICHFillHitsModule.cc.

◆ initialize() [10/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from Module.

Definition at line 66 of file ARICHPackerModule.cc.

◆ initialize() [11/11]

void initialize ( )
overridevirtual

Initialize the Module.

This method is called at the beginning of data processing.

Reimplemented from Module.

Definition at line 76 of file ARICHNtupleModule.cc.

◆ magFieldDistorsion()

void magFieldDistorsion ( TVector2 &  hit,
int  copyno 
)

Apply correction to hit position due to non-perpendicular component of magnetic field.

Parameters
hitlocal position of simhit
copynocopy number of hapd

Definition at line 211 of file ARICHDigitizerModule.cc.

◆ mergerClusterHitMap1D()

TH1 * mergerClusterHitMap1D ( TH1 *  hitMap,
int  mergerID 
)

Make 1D hit map of specified Merger Board.

Parameters
1Dhit map of all channels
Merferboard identifier [1:72]
Returns
1D hit map of the merger board

Definition at line 99 of file hitMapMaker.cc.

100  {
101 
102  int m_mergerID = mergerID;
103 
104  DBObjPtr<ARICHChannelMapping> arichChMap;
105  DBObjPtr<ARICHMergerMapping> arichMergerMap;
106 
107  TH1* m_hitMap = hitMap;
108 
109  std::vector<int> moduleIDs;
110  for (int i = 1; i < 7; i++) {
111  moduleIDs.push_back(arichMergerMap->getModuleID(m_mergerID, i));
112  }
113 
114  TH1D* m_mergerHitMap1D = new TH1D("MergerHitMap1D", Form("Hit map in Merger Board %d", m_mergerID), 144 * 6, -0.5, 144 * 6 - 0.5);
115  for (int i = 1; i < 7; i++) {
116  for (int j = 0; j < 144; j++) {
117  int hitsNum = m_hitMap->GetBinContent((moduleIDs[i] - 1) * 144 + i);
118  m_mergerHitMap1D->Fill(144 * (i - 1) + j, hitsNum);
119  }
120  }
121  return m_mergerHitMap1D;
122  }

◆ mergerClusterHitMap2D()

TCanvas * mergerClusterHitMap2D ( TH1 *  hitMap,
int  mergerID 
)

Make display of 6 HAPDs' 2D hit map of the Merger Board.

Parameters
1Dhit map of all channels
Merferboard identifier [1:72]
Returns
Display of 6 HAPDs' 2D hit map

Definition at line 124 of file hitMapMaker.cc.

◆ moduleDeadMap()

TH2 * moduleDeadMap ( TH1 *  hitMap,
int  moduleID 
)

Make chip dead/alive map in HAPD view (2*2 chips)

Parameters
1Dhit map of all channels
Moduleidentifier [1:420]
Returns
2D dead/alive map on HAPD

Definition at line 66 of file hitMapMaker.cc.

◆ moduleHitMap()

TH2 * moduleHitMap ( TH1 *  hitMap,
int  moduleID 
)

Make hit map in HAPD view (12*12 channels)

Parameters
1Dhit map of all channels
Moduleidentifier [1:420]
Returns
2D hit map on HAPD

Definition at line 42 of file hitMapMaker.cc.

◆ printBits()

void printBits ( const int *  buffer,
int  bufferSize 
)
private

Unpack raw data given in production format.

Parameters
bufferraw data buffer
bufferSizebuffer size

Definition at line 516 of file ARICHUnpackerModule.cc.

◆ sectorDeadMap()

TCanvas * sectorDeadMap ( TH1 *  hitMap,
int  sector 
)

Make display of 70 HAPDs' 2D dead/alive map of the sector.

Parameters
1Dhit map of all channels
Sectoridentifier [1:6]
Returns
Display of 70 HAPDs' 2D dead/alive map

Definition at line 180 of file hitMapMaker.cc.

◆ sectorHitMap()

TCanvas * sectorHitMap ( TH1 *  hitMap,
int  sector 
)

Make display of 70 HAPDs' 2D hit map of the sector.

Parameters
1Dhit map of all channels
Sectoridentifier [1:6]
Returns
Display of 70 HAPDs' 2D hit map

Definition at line 148 of file hitMapMaker.cc.

◆ terminate() [1/12]

void terminate ( )
overridevirtual

Is called at the end of your Module.

Function is called only once at the end of your job at the end of the corresponding module. This function is for cleaning up, closing files, etc.

Reimplemented from Module.

Definition at line 572 of file arichBtestModule.cc.

◆ terminate() [2/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from HistoModule.

Definition at line 171 of file ARICHRawUnpackerModule.cc.

◆ terminate() [3/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from Module.

Definition at line 112 of file ARICHMCParticlesModule.cc.

◆ terminate() [4/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from HistoModule.

Definition at line 164 of file ARICHRateCalModule.cc.

◆ terminate() [5/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from Module.

Definition at line 528 of file ARICHUnpackerModule.cc.

◆ terminate() [6/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from Module.

Definition at line 108 of file ARICHRelateModule.cc.

◆ terminate() [7/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from Module.

Definition at line 261 of file ARICHPackerModule.cc.

◆ terminate() [8/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from HistoModule.

Definition at line 496 of file ARICHDQMModule.cc.

◆ terminate() [9/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from Module.

Definition at line 240 of file ARICHReconstructorModule.cc.

◆ terminate() [10/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from Module.

Definition at line 173 of file ARICHFillHitsModule.cc.

◆ terminate() [11/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from Module.

Definition at line 234 of file ARICHDigitizerModule.cc.

◆ terminate() [12/12]

void terminate ( )
overridevirtual

Termination action.

Clean-up, close files, summarize statistics, etc.

Reimplemented from Module.

Definition at line 355 of file ARICHNtupleModule.cc.

Belle2::ARICHDQMModule::h_flashPerAPD
TH1 * h_flashPerAPD
Number of flashes in each APD.
Definition: ARICHDQMModule.h:125
Belle2::arichBtestModule::m_end
int m_end
EOF flag.
Definition: arichBtestModule.h:92
Belle2::ARICHDQMModule::h_hitsPerEvent
TH1 * h_hitsPerEvent
Ihe number of all hits in each event.
Definition: ARICHDQMModule.h:121
Belle2::ARICHRateCalModule::terminate
virtual void terminate() override
Termination action.
Definition: ARICHRateCalModule.cc:164
Belle2::ARICHDQMModule::h_hitsPerTrack2D
TH2 * h_hitsPerTrack2D
Sum of 2D hit/track map on each position of track.
Definition: ARICHDQMModule.h:116
Belle2::ARICHDQMModule::h_ARICHOccAfterInjLer
TH1 * h_ARICHOccAfterInjLer
Histogram Ndigits after LER injection.
Definition: ARICHDQMModule.h:130
Belle2::ARICHDQMModule::h_hapdHit
TH1 * h_hapdHit
The number of hits in each HAPD.
Definition: ARICHDQMModule.h:106
Belle2::Module::setDescription
void setDescription(const std::string &description)
Sets the description of the module.
Definition: Module.cc:216
Belle2::ARICHDQMModule::h_thetaPhi
TH2 * h_thetaPhi
cherenkov theta vs phi for non-mirror-reflected photons
Definition: ARICHDQMModule.h:120
Belle2::ARICHDQMModule::h_theta
TH1 * h_theta
Reconstructed Cherenkov angles.
Definition: ARICHDQMModule.h:122
Belle2::ARICHDQMModule::h_mergerHit
TH1 * h_mergerHit
The number of hits in each Merger Boards.
Definition: ARICHDQMModule.h:107
Belle2::ARICHDigitizerModule::m_bkgLevel
double m_bkgLevel
Number of background hits ped hapd per readout (electronics noise)
Definition: ARICHDigitizerModule.h:120
Belle2::ARICHDQMModule::h_ARICHOccAfterInjHer
TH1 * h_ARICHOccAfterInjHer
Histogram Ndigits after HER injection.
Definition: ARICHDQMModule.h:131
Belle2::ARICHDQMModule::h_chStat
TH1 * h_chStat
Status of each channels.
Definition: ARICHDQMModule.h:97
Belle2::ARICHDQMModule::h_aeroStat
TH1 * h_aeroStat
Status of each aerogel tiles.
Definition: ARICHDQMModule.h:98
Belle2::arichBtestModule::m_fp
gzFile m_fp
file desriptor of the data file
Definition: arichBtestModule.h:90
Belle2::ARICHDQMModule::h_secHitsPerTrack
TH1 * h_secHitsPerTrack[6]
Detailed average hits/track for each sector.
Definition: ARICHDQMModule.h:128
Belle2::ARICHDQMModule::h_chipHit
TH1 * h_chipHit
The number of hits in each ASIC chip.
Definition: ARICHDQMModule.h:105
Belle2::arichBtestModule::m_file
TFile * m_file
pointer to the root file
Definition: arichBtestModule.h:96
Belle2::ARICHDQMModule::h_ARICHEOccAfterInjHer
TH1 * h_ARICHEOccAfterInjHer
Histogram for Nr Entries (=Triggrs) for normalization after HER injection.
Definition: ARICHDQMModule.h:133
Belle2::ARICHDQMModule::h_aerogelHit
TH1 * h_aerogelHit
The number of reconstructed photons in each aerogel tiles.
Definition: ARICHDQMModule.h:113
Belle2::ARICHDQMModule::h_chHit
TH1 * h_chHit
The number of hits in each channel.
Definition: ARICHDQMModule.h:104
Belle2::arichBtestModule::m_mwpc
ARICHTracking * m_mwpc
Pointer to the tracking chambers.
Definition: arichBtestModule.h:109
Belle2::ARICHReconstruction::HitsMirror
bool HitsMirror(const TVector3 &pos, const TVector3 &dir, int mirrorID)
returns true if photon at position pos with direction dir hits mirror plate with ID mirrorID
Definition: ARICHReconstruction.cc:236
Belle2::arichBtestModule::m_tdc
int m_tdc[32]
raw MWPC TDC buffer
Definition: arichBtestModule.h:111
Belle2::ARICHDQMModule::h_trackPerEvent
TH1 * h_trackPerEvent
Number of tracks in ARICH per event (with p>0.5 GeV)
Definition: ARICHDQMModule.h:124
Belle2::ARICHDQMModule::h_mirrorThetaPhi
TH3 * h_mirrorThetaPhi
cherenkov theta vs phi for mirror reflected photons (for each mirror plate)
Definition: ARICHDQMModule.h:119
Belle2::ARICHDQMModule::h_hitsPerTrack
TH1 * h_hitsPerTrack
Average hits/track calculated from h_hits2D and h_track2D.
Definition: ARICHDQMModule.h:123
Belle2::arichBtestModule::m_events
int m_events
number of events
Definition: arichBtestModule.h:94
Belle2::arichBtestModule::m_beamMomentum
double m_beamMomentum
Momentum of the particles in the beam [GeV].
Definition: arichBtestModule.h:118
Belle2::Module::Module
Module()
Constructor.
Definition: Module.cc:32
Belle2::Module::addParam
void addParam(const std::string &name, T &paramVariable, const std::string &description, const T &defaultValue)
Adds a new parameter to the module.
Definition: Module.h:562
Belle2::ARICHDQMModule::h_chDigit
TH1 * h_chDigit
The number of raw digits in each channel.
Definition: ARICHDQMModule.h:101
Belle2::ARICHDQMModule::h_ARICHEOccAfterInjLer
TH1 * h_ARICHEOccAfterInjLer
Histogram for Nr Entries (=Triggrs) for normalization after LER injection.
Definition: ARICHDQMModule.h:132
Belle2::arichBtestModule::m_runList
std::vector< std::string > m_runList
The filenames of the runs.
Definition: arichBtestModule.h:98
Belle2::ARICHDQMModule::h_hapdDigit
TH1 * h_hapdDigit
The number of raw digits in each HAPD.
Definition: ARICHDQMModule.h:103
Belle2::arichBtestModule::m_MwpcTrackMask
std::vector< int > m_MwpcTrackMask
Bit mask of the MWPC tracking chambers used for the track creation.
Definition: arichBtestModule.h:105
Belle2::ARICHDQMModule::h_secTheta
TH1 * h_secTheta[6]
Detailed view of Cherenkov angle for each sector.
Definition: ARICHDQMModule.h:127
Belle2::arichBtestModule::m_outFile
std::string m_outFile
output file name
Definition: arichBtestModule.h:103
Belle2::ARICHDQMModule::h_chipDigit
TH1 * h_chipDigit
The number of raw digits in each ASIC chip.
Definition: ARICHDQMModule.h:102
Belle2::ARICHDQMModule::h_bits
TH1 * h_bits
Timing bits.
Definition: ARICHDQMModule.h:114
Belle2::ARICHReconstruction::m_arichgp
DBObjPtr< ARICHGeometryConfig > m_arichgp
geometry configuration parameters from the DB
Definition: ARICHReconstruction.h:102
Belle2::ARICHDigitizerModule::m_simPar
DBObjPtr< ARICHSimulationPar > m_simPar
simulation parameters from the DB
Definition: ARICHDigitizerModule.h:112
Belle2::arichBtestModule::m_timestart
time_t m_timestart
time of the first processed event
Definition: arichBtestModule.h:107
Belle2::ARICHDQMModule::h_tracks2D
TH2 * h_tracks2D
2D track distribution of whole ARICH
Definition: ARICHDQMModule.h:117
Belle2::ARICHDQMModule::h_aerogelHits3D
TH3 * h_aerogelHits3D
3D histogram of
Definition: ARICHDQMModule.h:118