Class Reference for E1039 Core & Analysis Software
PHG4CylinderCellTPCReco.cc
Go to the documentation of this file.
2 #include "PHG4CellContainer.h"
3 #include "PHG4CellDefs.h"
4 #include "PHG4Cellv1.h"
5 #include "PHG4Cellv2.h"
6 #include "PHG4CylinderCellGeom.h"
8 #include "PHG4CylinderGeom.h"
10 #include "PHG4TPCDistortion.h"
11 
12 #include <g4main/PHG4Hit.h>
14 
16 #include <fun4all/Fun4AllServer.h>
17 
18 #include <phool/PHCompositeNode.h>
19 #include <phool/PHIODataNode.h>
20 #include <phool/PHNodeIterator.h>
21 #include <phool/PHRandomSeed.h>
22 #include <phool/getClass.h>
23 
24 #include <TH1F.h>
25 #include <TF1.h>
26 #include <TProfile2D.h>
27 #include <TROOT.h>
28 #include <TSystem.h>
29 
30 #include <CLHEP/Units/PhysicalConstants.h>
31 #include <CLHEP/Units/SystemOfUnits.h>
32 
33 #include <gsl/gsl_randist.h>
34 
35 #include <cmath>
36 #include <cstdlib>
37 #include <iostream>
38 #include <limits>
39 #include <sstream>
40 
41 using namespace std;
42 
44  const string &name)
45  : SubsysReco(name)
46  , _timer(PHTimeServer::get()->insert_new(name))
47  , fHalfLength(100)
48  , fDiffusionT(0.0057)
49  , fDiffusionL(0.0057)
50  , sigmaT(0.04)
51  , elec_per_gev(38. * 1e6)
52  , driftv(3.0 / 1000.0)
53  , fpad{nullptr,nullptr,nullptr,nullptr,nullptr,nullptr,nullptr,nullptr,nullptr,nullptr}
54  , fcharge(nullptr)
55  , // cm per ns
56  num_pixel_layers(n_pixel)
57  , tmin_default(0.0)
58  , // ns
59  tmax_default(60.0)
60  , // ns
61  tmin_max()
62  , distortion(NULL)
63  , fHElectrons(NULL)
64  , fHWindowP(NULL)
65  , fHWindowZ(NULL)
66  , fHMeanEDepPerCell(NULL)
67  , fHMeanElectronsPerCell(NULL)
68  , fHErrorRPhi(NULL)
69  , fHErrorZ(NULL)
70  , fFractRPsm(0.0)
71  , fFractZZsm(0.0)
72  , fShapingLead(32.0 * 3.0 / 1000.0)
73  , // ns
74  fShapingTail(48.0 * 3.0 / 1000.0) // ns
75  , zigzag_pads(1)
76 {
77  memset(nbins, 0, sizeof(nbins));
78  unsigned int seed = PHRandomSeed(); // fixed seed is handled in this funtcion
79  cout << Name() << " random seed: " << seed << endl;
80  RandomGenerator = gsl_rng_alloc(gsl_rng_mt19937);
81  gsl_rng_set(RandomGenerator, seed);
82 }
83 
85 {
86  gsl_rng_free(RandomGenerator);
87  delete distortion;
88 }
89 
90 void PHG4CylinderCellTPCReco::Detector(const std::string &d)
91 {
92  detector = d;
93  // only set the outdetector nodename if it wasn't set already
94  // in case the order in the macro is outdetector(); detector();
95  if (outdetector.size() == 0)
96  {
97  OutputDetector(d);
98  }
99  return;
100 }
101 
102 void PHG4CylinderCellTPCReco::cellsize(const int i, const double sr, const double sz)
103 {
104  cell_size[i] = std::make_pair(sr, sz);
105 }
106 
108 {
109  if (verbosity > 1)
110  {
112  fHWindowP = new TProfile2D("TPCGEO_WindowP", "TPCGEO_WindowP", 50, -0.5, 49.5, 220, -110, +110);
114  fHWindowZ = new TProfile2D("TPCGEO_WindowZ", "TPCGEO_WindowZ", 50, -0.5, 49.5, 220, -110, +110);
116  fHElectrons = new TH1F("TPCGEO_GeneratedElectrons", "TPCGEO_GeneratedElectrons", 100, 0, 200);
118  fHMeanEDepPerCell = new TProfile2D("TPCGEO_Edep", "TPCGEO_Edep", 50, -0.5, 49.5, 220, -110, +110);
120  fHMeanElectronsPerCell = new TProfile2D("TPCGEO_Electrons", "TPCGEO_Electrons", 50, -0.5, 49.5, 220, -110, +110);
122  fHErrorRPhi = new TProfile2D("TPCGEO_CloudSizeRPhi", "TPCGEO_CloudSizeRPhi", 50, -0.5, 49.5, 220, -110, +110);
124  fHErrorZ = new TProfile2D("TPCGEO_CloudSizeZ", "TPCGEO_CloudSizeZ", 50, -0.5, 49.5, 220, -110, +110);
125  se->registerHisto(fHErrorZ);
126  }
127 
129 }
130 
132 {
133  PHNodeIterator iter(topNode);
134 
135  PHCompositeNode *dstNode;
136  dstNode = dynamic_cast<PHCompositeNode *>(iter.findFirst("PHCompositeNode", "DST"));
137  if (!dstNode)
138  {
139  std::cout << PHWHERE << "DST Node missing, doing nothing." << std::endl;
140  exit(1);
141  }
142  hitnodename = "G4HIT_" + detector;
143  PHG4HitContainer *g4hit = findNode::getClass<PHG4HitContainer>(topNode, hitnodename.c_str());
144  if (!g4hit)
145  {
146  cout << "Could not locate g4 hit node " << hitnodename << endl;
147  exit(1);
148  }
149  cellnodename = "G4CELL_" + outdetector;
150  PHG4CellContainer *cells = findNode::getClass<PHG4CellContainer>(topNode, cellnodename);
151  if (!cells)
152  {
153  cells = new PHG4CellContainer();
154  PHIODataNode<PHObject> *newNode = new PHIODataNode<PHObject>(cells, cellnodename.c_str(), "PHObject");
155  dstNode->addNode(newNode);
156  }
157  geonodename = "CYLINDERGEOM_" + detector;
158  PHG4CylinderGeomContainer *geo = findNode::getClass<PHG4CylinderGeomContainer>(topNode, geonodename.c_str());
159  if (!geo)
160  {
161  cout << "Could not locate geometry node " << geonodename << endl;
162  exit(1);
163  }
164  seggeonodename = "CYLINDERCELLGEOM_" + outdetector;
165  PHG4CylinderCellGeomContainer *seggeo = findNode::getClass<PHG4CylinderCellGeomContainer>(topNode, seggeonodename.c_str());
166  if (!seggeo)
167  {
168  seggeo = new PHG4CylinderCellGeomContainer();
169  PHCompositeNode *runNode = dynamic_cast<PHCompositeNode *>(iter.findFirst("PHCompositeNode", "RUN"));
170  PHIODataNode<PHObject> *newNode = new PHIODataNode<PHObject>(seggeo, seggeonodename.c_str(), "PHObject");
171  runNode->addNode(newNode);
172  }
173 
174  map<int, PHG4CylinderGeom *>::const_iterator miter;
175  pair<map<int, PHG4CylinderGeom *>::const_iterator, map<int, PHG4CylinderGeom *>::const_iterator> begin_end = geo->get_begin_end();
176  map<int, std::pair<double, double> >::iterator sizeiter;
177  for (miter = begin_end.first; miter != begin_end.second; ++miter)
178  {
179  PHG4CylinderGeom *layergeom = miter->second;
180  int layer = layergeom->get_layer();
181  double circumference = layergeom->get_radius() * 2 * M_PI;
182  double length_in_z = layergeom->get_zmax() - layergeom->get_zmin();
183  sizeiter = cell_size.find(layer);
184  if (sizeiter == cell_size.end())
185  {
186  cout << "no cell sizes for layer " << layer << endl;
187  exit(1);
188  }
189  PHG4CylinderCellGeom *layerseggeo = new PHG4CylinderCellGeom();
190  layerseggeo->set_layer(layergeom->get_layer());
191  layerseggeo->set_radius(layergeom->get_radius());
192  layerseggeo->set_thickness(layergeom->get_thickness());
193 
194  double size_z = (sizeiter->second).second;
195  double size_r = (sizeiter->second).first;
196  double bins_r;
197  // unlikely but if the circumference is a multiple of the cell size
198  // use result of division, if not - add 1 bin which makes the
199  // cells a tiny bit smaller but makes them fit
200  double fract = modf(circumference / size_r, &bins_r);
201  if (fract != 0)
202  {
203  bins_r++;
204  }
205  nbins[0] = bins_r;
206  size_r = circumference / bins_r;
207  (sizeiter->second).first = size_r;
208  double phistepsize = 2 * M_PI / bins_r;
209  double phimin = -M_PI;
210  double phimax = phimin + phistepsize;
211  phistep[layer] = phistepsize;
212  for (int i = 0; i < nbins[0]; i++)
213  {
214  phimax += phistepsize;
215  }
216  // unlikely but if the length is a multiple of the cell size
217  // use result of division, if not - add 1 bin which makes the
218  // cells a tiny bit smaller but makes them fit
219  fract = modf(length_in_z / size_z, &bins_r);
220  if (fract != 0)
221  {
222  bins_r++;
223  }
224  nbins[1] = bins_r;
225  pair<int, int> phi_z_bin = make_pair(nbins[0], nbins[1]);
226  n_phi_z_bins[layer] = phi_z_bin;
227  // update our map with the new sizes
228  size_z = length_in_z / bins_r;
229  (sizeiter->second).second = size_z;
230  double zlow = layergeom->get_zmin();
231  double zhigh = zlow + size_z;
232  ;
233  for (int i = 0; i < nbins[1]; i++)
234  {
235  zhigh += size_z;
236  }
238  layerseggeo->set_zbins(nbins[1]);
239  layerseggeo->set_zmin(layergeom->get_zmin());
240  layerseggeo->set_zstep(size_z);
241  layerseggeo->set_phibins(nbins[0]);
242  layerseggeo->set_phistep(phistepsize);
243  // Chris Pinkenburg: greater causes huge memory growth which causes problems
244  // on our farm. If you need to increase this - TALK TO ME first
245  if (nbins[1] * nbins[0] > 5100000)
246  {
247  cout << "increase TPC cellsize, number of cells "
248  << nbins[1] * nbins[0] << " for layer " << layer
249  << " exceed 5.1M limit" << endl;
250  cout << "minimum working values for cells are 0.12/0.17" << endl;
251  gSystem->Exit(1);
252  }
253  seggeo->AddLayerCellGeom(layerseggeo);
254  }
255 
256  for (std::map<int, int>::iterator iter = binning.begin();
257  iter != binning.end(); ++iter)
258  {
259  int layer = iter->first;
260  // if the user doesn't set an integration window, set the default
261  tmin_max.insert(std::make_pair(layer, std::make_pair(tmin_default, tmax_default)));
262  }
263 
264  fcharge = new TF1("fcharge", "gaus(0)");
265 
266  for(int ipad = 0;ipad < 10; ipad++)
267  {
268  char name[500];
269  sprintf(name,"fpad%i",ipad);
270  fpad[ipad] = new TF1(name,"[0]-abs(x-[1])");
271  }
272 
273  cout << "The TPC zigzag pad option is set to " << zigzag_pads << endl;
274 
276 }
277 
279 {
280  _timer.get()->restart();
281  PHG4HitContainer *g4hit = findNode::getClass<PHG4HitContainer>(topNode, hitnodename.c_str());
282  if (!g4hit)
283  {
284  cout << "Could not locate g4 hit node " << hitnodename << endl;
285  exit(1);
286  }
287  PHG4CellContainer *cells = findNode::getClass<PHG4CellContainer>(topNode, cellnodename);
288  if (!cells)
289  {
290  cout << "could not locate cell node " << cellnodename << endl;
291  exit(1);
292  }
293  PHG4CylinderCellGeomContainer *seggeo = findNode::getClass<PHG4CylinderCellGeomContainer>(topNode, seggeonodename.c_str());
294  if (!seggeo)
295  {
296  cout << "could not locate geo node " << seggeonodename << endl;
297  exit(1);
298  }
299 
300  map<int, std::pair<double, double> >::iterator sizeiter;
302  pair<PHG4HitContainer::LayerIter, PHG4HitContainer::LayerIter> layer_begin_end = g4hit->getLayers();
303  for (layer = layer_begin_end.first; layer != layer_begin_end.second; layer++)
304  {
305  std::map<unsigned long long, PHG4Cell *> cellptmap;
307  PHG4HitContainer::ConstRange hit_begin_end = g4hit->getHits(*layer);
308  PHG4CylinderCellGeom *geo = seggeo->GetLayerCellGeom(*layer);
309  if (verbosity > 1000)
310  {
311  std::cout << "Layer " << (*layer);
312  std::cout << " Radius " << geo->get_radius();
313  std::cout << " Thickness " << geo->get_thickness();
314  std::cout << " zmin " << geo->get_zmin();
315  std::cout << " nbinsz " << geo->get_zbins();
316  std::cout << " phimin " << geo->get_phimin();
317  std::cout << " nbinsphi " << geo->get_phibins();
318  std::cout << std::endl;
319  }
320 
321  int nphibins = n_phi_z_bins[*layer].first;
322  int nzbins = n_phi_z_bins[*layer].second;
323 
324  sizeiter = cell_size.find(*layer);
325  if (sizeiter == cell_size.end())
326  {
327  cout << "logical screwup!!! no sizes for layer " << *layer << endl;
328  exit(1);
329  }
330  //double zstepsize = (sizeiter->second).second;
331  //double phistepsize = phistep[*layer];
332  for (hiter = hit_begin_end.first; hiter != hit_begin_end.second; hiter++)
333  {
334  // checking ADC timing integration window cut
335  if (hiter->second->get_t(0) > tmin_max[*layer].second) continue;
336  if (hiter->second->get_t(1) < tmin_max[*layer].first) continue;
337 
338  double xinout;
339  double yinout;
340  double phi;
341  double z;
342  int phibin;
343  int zbin;
344  xinout = hiter->second->get_avg_x();
345  yinout = hiter->second->get_avg_y();
346  double r = sqrt(xinout * xinout + yinout * yinout);
347  phi = atan2(hiter->second->get_avg_y(), hiter->second->get_avg_x());
348  z = hiter->second->get_avg_z();
349  if (verbosity > 2000)
350  cout << "loop over hits, hit avge z = " << hiter->second->get_avg_z()
351  << " hit avge x = " << hiter->second->get_avg_x()
352  << " hit avge y = " << hiter->second->get_avg_y()
353  << " phi = " << phi
354  << endl;
355 
356  double truth_phi = phi; // keep the truth phi for later
357  double truth_z = z; // keep the truth phi for later
358 
359  // apply primary charge distortion
360  if ((*layer) >= (unsigned int) num_pixel_layers)
361  { // in TPC
362  if (distortion)
363  {
364  // do TPC distortion
365  const double dz = distortion->get_z_distortion(r, phi, z);
366  const double drphi = distortion->get_rphi_distortion(r, phi, z);
367  //TODO: radial distortion is not applied at the moment,
368  // because it leads to major change to the structure of this code and it affect the insensitive direction to
369  // near radial tracks
370  //
371  // const double dr = distortion ->get_r_distortion(r,phi,z);
372  phi += drphi / r;
373  z += dz;
374  }
375  //TODO: this is an approximation of average track propagation time correction on a cluster's hit time or z-position.
376  // Full simulation require implement this correction in PHG4TPCClusterizer::process_event
377  const double approximate_cluster_path_length = sqrt(
378  hiter->second->get_avg_x() * hiter->second->get_avg_x() + hiter->second->get_avg_y() * hiter->second->get_avg_y() + hiter->second->get_avg_z() * hiter->second->get_avg_z());
379  const double speed_of_light_cm_ns = CLHEP::c_light / (CLHEP::centimeter / CLHEP::nanosecond);
380  if (z >= 0.0)
381  z -= driftv * (hiter->second->get_avg_t() - approximate_cluster_path_length / speed_of_light_cm_ns);
382  else
383  z += driftv * (hiter->second->get_avg_t() - approximate_cluster_path_length / speed_of_light_cm_ns);
384  }
385  phibin = geo->get_phibin(phi);
386  if (phibin < 0 || phibin >= nphibins)
387  {
388  continue;
389  }
390  double phidisp = phi - geo->get_phicenter(phibin);
391 
392  zbin = geo->get_zbin(hiter->second->get_avg_z());
393  if (zbin < 0 || zbin >= nzbins)
394  {
395  continue;
396  }
397  double zdisp = z - geo->get_zcenter(zbin);
398 
399  double edep = hiter->second->get_edep();
400  if (verbosity > 1)
401  {
402  fHMeanEDepPerCell->Fill(float(*layer), z, edep);
403  }
404  if (verbosity > 2000) cout << "Find or start a cell for this hit" << endl;
405 
406  if ((*layer) < (unsigned int) num_pixel_layers)
407  { // MAPS + ITT
408  unsigned long long longphibins = nphibins;
409  unsigned long long key = zbin * longphibins + phibin;
410  std::map<unsigned long long, PHG4Cell *>::iterator it = cellptmap.find(key);
411  PHG4Cell *cell;
412  if (it != cellptmap.end())
413  {
414  cell = it->second;
415  }
416  else
417  {
418  PHG4CellDefs::keytype akey = PHG4CellDefs::SizeBinning::genkey(*layer, zbin, phibin);
419  cell = new PHG4Cellv1(akey);
420  cellptmap[key] = cell;
421  }
422  cell->add_edep(hiter->first, edep);
423  cell->add_edep(edep);
424  cell->add_shower_edep(hiter->second->get_shower_id(), edep);
425 // if (hiter->second->has_property(PHG4Hit::prop_eion)) cell->add_eion(hiter->second->get_eion());
426  }
427  else
428  { // TPC
429  // converting Edep to Total Number Of Electrons
430  float eion = hiter->second->get_eion();
431  if (!isfinite(eion))
432  {
433  eion = edep;
434  }
435  if (eion <= 0) // no ionization energy - skip to next hit
436  {
437  continue;
438  }
439  double nelec = gsl_ran_poisson(RandomGenerator, elec_per_gev * eion);
440  if (verbosity > 1)
441  {
442  fHElectrons->Fill(nelec);
443  }
444 
445  // The resolution due to pad readout includes the charge spread during GEM multiplication.
446  // this now defaults to 400 microns during construction from Tom (see 8/11 email).
447  // Use the setSigmaT(const double) method to update...
448  // We use a double gaussian to represent the smearing due to the SAMPA chip shaping time - default values of fShapingLead and fShapingTail are 0.19 and 0.285 cm
449  double sigmaL[2];
450  // These are calculated (in cm) in the macro from the shaping RMS times and the gas drift velocity
451  sigmaL[0] = fShapingLead;
452  sigmaL[1] = fShapingTail;
453  double cloud_sig_rp = sqrt(fDiffusionT * fDiffusionT * (fHalfLength - fabs(hiter->second->get_avg_z())) + sigmaT * sigmaT);
454  double cloud_sig_zz[2];
455  cloud_sig_zz[0] = sqrt(fDiffusionL * fDiffusionL * (fHalfLength - fabs(hiter->second->get_avg_z())) + sigmaL[0] * sigmaL[0]);
456  cloud_sig_zz[1] = sqrt(fDiffusionL * fDiffusionL * (fHalfLength - fabs(hiter->second->get_avg_z())) + sigmaL[1] * sigmaL[1]);
457 
458  //===============
459  // adding a random displacement, parameter is set in the macro
460  // This just randomly offsets the cluster position to simulate the cluster resolution expected from a back of the enevelope calculation
461  phi += fFractRPsm * gsl_ran_gaussian(RandomGenerator, cloud_sig_rp) / r;
462  if (phi > +M_PI) phi -= 2 * M_PI;
463  if (phi < -M_PI) phi += 2 * M_PI;
464  z += fFractZZsm * gsl_ran_gaussian(RandomGenerator, cloud_sig_zz[0]);
465 
466  // moving center
467  phibin = geo->get_phibin(phi);
468  zbin = geo->get_zbin(z);
469  // bin protection
470  if (phibin < 0 || phibin >= nphibins)
471  {
472  continue;
473  }
474  if (zbin < 0 || zbin >= nzbins)
475  {
476  continue;
477  }
478  // bincenter correction
479  phidisp = phi - geo->get_phicenter(phibin);
480  zdisp = z - geo->get_zcenter(zbin);
481  // increase cloud sigma too
482  cloud_sig_rp *= (1 + fFractRPsm);
483  cloud_sig_zz[0] *= (1 + fFractZZsm);
484  cloud_sig_zz[1] *= (1 + fFractZZsm);
485 
486  if (verbosity > 2000)
487  cout << "After adding random displacement: phi = " << phi << " z = " << z << " phibin = " << phibin << " zbin = " << zbin << endl
488  << " phidisp = " << phidisp << " zdisp = " << zdisp << " new cloud_sig_rp " << cloud_sig_rp << " cloud_sig_zz[0] " << cloud_sig_zz[0]
489  << " cloud_sig_zz[1] " << cloud_sig_zz[1] << endl;
490 
491  //=====
492 
493  // We should account for the fact that angled tracks deposit charge in a range of Z values, increasing the cluster Z length
494  // The new software is proposed to deal with this by using a single volume with a step size of ~0.3 cm, so 4 steps per layer. Let's use 7.
495  // Start with the entry and exit Z values for the track in this layer. These have to come from the G4 hit.
496  // Make nseg segment centers - keep nseg odd - process each segment through the shaper and ADC binning
497 
498  // Note that we ignore the difference in drift-diffusion between segments here, for convenience - it will be tiny
499 
500  double zrange = fabs(hiter->second->get_z(1) - hiter->second->get_z(0));
501  if (verbosity > 2000) cout << " *********** zrange " << zrange << " zout " << hiter->second->get_z(1) << " zin " << hiter->second->get_z(0) << endl;
502 
503  int nseg = (int)zrange/cloud_sig_zz[0]; // must be odd number
504  if(nseg%2==0)nseg+=1;
505  // loop over the segment centers and distribute charge to the cells from each one
506  for (int izr = 0; izr < nseg; izr++)
507  {
508  double zsegoffset = (izr - nseg / 2) * zrange / nseg;
509 
510  // offsetting z from the average for the layer may change the zbin, fix that
511  int zbinseg = zbin = geo->get_zbin(z + zsegoffset);
512  if (zbinseg < 0 || zbinseg >= nzbins)
513  {
514  continue;
515  }
516  double zdispseg = z + zsegoffset - geo->get_zcenter(zbinseg);
517 
518  if (verbosity > 2000) cout << " ---------- segment izr = " << izr << " with zsegoffset " << zsegoffset << " zbinseg " << zbinseg << " zdispseg " << zdispseg << endl;
519 
520  // Now distribute the charge between the pads in phi
521  //====================================
522 
523  // bin in phi
524  // ========
525 
526  pad_phibin.clear();
527  pad_phibin_share.clear();
528  if(zigzag_pads)
529  populate_zigzag_phibins(geo, phi, cloud_sig_rp, pad_phibin, pad_phibin_share);
530  else
531  populate_rectangular_phibins(geo, phi, cloud_sig_rp, pad_phibin, pad_phibin_share);
532 
533  // Normalize the shares so they add up to 1
534  double norm1 = 0.0;
535  for(unsigned int ipad = 0; ipad < pad_phibin.size(); ++ipad)
536  {
537  double pad_share = pad_phibin_share[ipad];
538  norm1 += pad_share;
539  }
540  for(unsigned int iphi = 0; iphi < pad_phibin.size(); ++iphi)
541  pad_phibin_share[iphi] /= norm1;
542 
543  // Now distribute the charge between the pads in z
544  //====================================
545  adc_zbin.clear();
546  adc_zbin_share.clear();
547  populate_zbins(geo, z + zsegoffset, cloud_sig_zz, adc_zbin, adc_zbin_share);
548 
549  // Normalize the shares so that they add up to 1
550  double znorm = 0.0;
551  for(unsigned int iz = 0; iz < adc_zbin.size(); ++iz)
552  {
553  double bin_share = adc_zbin_share[iz];
554  znorm += bin_share;
555  }
556  for(unsigned int iz = 0; iz < adc_zbin.size(); ++iz)
557  adc_zbin_share[iz] /= znorm;
558 
559  // Fill cells
560  //========
561  // These are used to do a quick clustering for checking
562  double phi_integral = 0.0;
563  double z_integral = 0.0;
564  double weight = 0.0;
565 
566  for(unsigned int ipad = 0; ipad < pad_phibin.size(); ++ipad)
567  {
568  int pad_num = pad_phibin[ipad];
569  double pad_share = pad_phibin_share[ipad];
570 
571  for(unsigned int iz = 0; iz<adc_zbin.size(); ++iz)
572  {
573  int zbin_num = adc_zbin[iz];
574  double adc_bin_share = adc_zbin_share[iz];
575 
576  // adding constant electron avalanche (value chosen so that digitizer will not trip)
577  float neffelectrons = (2000.0 / nseg) * nelec * (pad_share) * (adc_bin_share);
578 
579  if (neffelectrons < 50) continue; // skip no or very small signals to keep number of cells down
580  if(zbin_num >= nzbins) cout << " Error making key: adc_zbin " << zbin_num << " nzbins " << nzbins << endl;
581  if(pad_num >= nphibins) cout << " Error making key: pad_phibin " << pad_num << " nphibins " << nphibins << endl;
582  unsigned long key = zbin_num * nphibins + pad_num;
583 
584  if(verbosity > 5000)
585  cout << " zbin " << zbin_num << " z of bin " << geo->get_zcenter(zbin_num) << " z integral " << adc_bin_share
586  << " pad " << pad_num << " phi of pad " << geo->get_phicenter(pad_num) << " phi integral " << pad_share
587  << " nelectrons = " << neffelectrons << " key = " << key << endl;
588 
589  // collect information to do simple clustering. Checks operation of PHG4CylinderCellTPCReco, and
590  // is also useful for comparison with PHG4TPCClusterizer result when running single track events.
591  // The only information written to the cell other than neffelectrons is zbin and pad number, so get those from geometry
592  double phicenter = geo->get_phicenter(pad_num);
593  phi_integral += phicenter*neffelectrons;
594  double zcenter = geo->get_zcenter(zbin_num);
595  z_integral += zcenter*neffelectrons;
596  weight += neffelectrons;
597 
598  std::map<unsigned long long, PHG4Cell *>::iterator it = cellptmap.find(key);
599  PHG4Cell *cell;
600  if (it != cellptmap.end())
601  {
602  cell = it->second;
603  }
604  else
605  {
606  PHG4CellDefs::keytype akey = PHG4CellDefs::SizeBinning::genkey(*layer, zbin_num, pad_num);
607  cell = new PHG4Cellv2(akey);
608  cellptmap[key] = cell;
609  }
610  cell->add_edep(hiter->first, neffelectrons);
611  cell->add_edep(neffelectrons);
612  cell->add_shower_edep(hiter->second->get_shower_id(), neffelectrons);
613 
614  } // end of loop over adc bins
615  } // end of loop over zigzag pads
616 
617  if(verbosity > 5000)
618  {
619  cout << " quick centroid using neffelectrons " << endl;
620  cout << " phi centroid = " << phi_integral / weight << " truth phi " << truth_phi << " z centroid = " << z_integral / weight << " truth z " << truth_z << endl;
621  }
622 
623  } // izr
624  }
625  }
626  int count = 0;
627  for (std::map<unsigned long long, PHG4Cell *>::iterator it = cellptmap.begin(); it != cellptmap.end(); ++it)
628  {
629  cells->AddCell(it->second);
630  int phibin = PHG4CellDefs::SizeBinning::get_phibin(it->second->get_cellid());
631  int zbin = PHG4CellDefs::SizeBinning::get_zbin(it->second->get_cellid());
632  if (verbosity > 1)
633  {
634  float zthis = geo->get_zcenter(zbin);
635  fHMeanElectronsPerCell->Fill(float(*layer), zthis, it->second->get_edep());
636  }
637  if (verbosity > 2000)
638  std::cout << " Adding phibin " << phibin << " zbin " << zbin << " with edep " << it->second->get_edep() << std::endl;
639  count += 1;
640  }
641  if (verbosity > 1000)
642  std::cout << " || Number of cells hit " << count << std::endl;
643  }
644  if (verbosity > 1000) std::cout << "PHG4CylinderCellTPCReco end" << std::endl;
645  _timer.get()->stop();
647 }
648 
649 void PHG4CylinderCellTPCReco::populate_rectangular_phibins(PHG4CylinderCellGeom *geo, const double phi, const double cloud_sig_rp, std::vector<int> &pad_phibin, std::vector<double> &pad_phibin_share)
650 {
651  double cloud_sig_rp_inv = 1. / cloud_sig_rp;
652 
653  int phibin = geo->get_phibin(phi);
654  int nphibins = geo->get_phibins();
655 
656  double radius = geo->get_radius() + geo->get_thickness()/2.0;
657  double phidisp = phi - geo->get_phicenter(phibin);
658  double phistepsize = geo->get_phistep();
659 
660  // bin the charge in phi - rectangular pads
661  int n_rp = int(3 * cloud_sig_rp / (radius * phistepsize) + 1);
662  for (int iphi = -n_rp; iphi != n_rp + 1; ++iphi)
663  {
664  int cur_phi_bin = phibin + iphi;
665  // correcting for continuity in phi
666  if (cur_phi_bin < 0)
667  cur_phi_bin += nphibins;
668  else if (cur_phi_bin >= nphibins)
669  cur_phi_bin -= nphibins;
670  if ((cur_phi_bin < 0) || (cur_phi_bin >= nphibins))
671  {
672  std::cout << "PHG4CylinderCellTPCReco => error in phi continuity. Skipping" << std::endl;
673  continue;
674  }
675  // Get the integral of the charge probability distribution in phi inside the current phi step
676  double phiLim1 = 0.5 * M_SQRT2 * ((iphi + 0.5) * phistepsize * radius - phidisp * radius) * cloud_sig_rp_inv;
677  double phiLim2 = 0.5 * M_SQRT2 * ((iphi - 0.5) * phistepsize * radius - phidisp * radius) * cloud_sig_rp_inv;
678  double phi_integral = 0.5 * (erf(phiLim1) - erf(phiLim2));
679 
680  pad_phibin.push_back(cur_phi_bin);
681  pad_phibin_share.push_back(phi_integral);
682 
683  }
684 
685  return;
686 }
687 
688 void PHG4CylinderCellTPCReco::populate_zigzag_phibins(PHG4CylinderCellGeom *geo, const double phi, const double cloud_sig_rp, std::vector<int> &pad_phibin, std::vector<double> &pad_phibin_share)
689 {
690  double nsigmas = 5.0;
691 
692  // make the charge distribution gaussian
693  double rphi = phi * (geo->get_radius() + geo->get_thickness() / 2.0);
694  fcharge->SetParameter(0, 1.0);
695  fcharge->SetParameter(1, rphi);
696  fcharge->SetParameter(2, cloud_sig_rp);
697  if(verbosity > 5000) cout << " fcharge created: radius " << (geo->get_radius() + geo->get_thickness() / 2.0) << " rphi " << rphi << " cloud_sig_rp " << cloud_sig_rp << endl;
698 
699  // Get the range of phi values that completely contains all pads that touch the charge distribution - (nsigmas + 1/2 pad width) in each direction
700  double philim_low = phi - nsigmas * cloud_sig_rp / ( (geo->get_radius() + geo->get_thickness() / 2.0) - geo->get_phistep() );
701  double philim_high = phi + nsigmas * cloud_sig_rp / ( (geo->get_radius() + geo->get_thickness() / 2.0) + geo->get_phistep() );
702 
703  // Find the pad range that covers this phi range
704  double phibin_low = geo->get_phibin(philim_low);
705  double phibin_high = geo->get_phibin(philim_high);
706  int npads = phibin_high - phibin_low;
707  if(verbosity>5000) cout << " zigzags: phi " << phi << " philim_low " << philim_low << " phibin_low " << phibin_low
708  << " philim_high " << philim_high << " phibin_high " << phibin_high << " npads " << npads << endl;
709  if(npads < 0 || npads >9) npads = 9; // can happen if phibin_high wraps around. If so, limit to 10 pads and fix below
710 
711 
712  // Calculate the maximum extent in r-phi of pads in this layer. Pads are assumed to touch the center of the next phi bin on both sides.
713  double pad_rphi = 2.0 * (geo->get_phistep()) * (geo->get_radius() + geo->get_thickness() / 2.0);
714  // Make a TF1 for each pad in the phi range
715  int pad_keep[10];
716  for(int ipad = 0; ipad<=npads;ipad++)
717  {
718  int pad_now = phibin_low + ipad;
719  // check that we do not exceed the maximum number of pads, wrap if necessary
720  if(pad_now >= geo->get_phibins()) pad_now -= geo->get_phibins();
721 
722  pad_keep[ipad] = pad_now;
723  double rphi_pad_now = geo->get_phicenter(pad_now) * (geo->get_radius() + geo->get_thickness() / 2.0);
724 
725  fpad[ipad]->SetParameter(0,pad_rphi/2.0);
726  fpad[ipad]->SetParameter(1, rphi_pad_now);
727 
728  if(verbosity>5000) cout << " zigzags: make fpad for ipad " << ipad << " pad_now " << pad_now << " pad_rphi/2 " << pad_rphi/2.0
729  << " rphi_pad_now " << rphi_pad_now << endl;
730  }
731 
732  // Now make a loop that steps through the charge distribution and evaluates the response at that point on each pad
733 
734  double overlap[10];
735  for(int i=0;i<10;i++)
736  overlap[i]=0;
737 
738  int nsteps = 100;
739  double xstep = 2.0 * nsigmas * cloud_sig_rp / (double) nsteps;
740  for(int i=0;i<nsteps;i++)
741  {
742  double x = rphi - 4.5 * cloud_sig_rp + (double) i * xstep;
743  double charge = fcharge->Eval(x);
744  //cout << " i " << i << " x " << x << " charge " << charge << endl;
745  for(int ipad = 0;ipad<=npads;ipad++)
746  {
747  if(fpad[ipad]->Eval(x) > 0.0)
748  {
749  double prod = charge * fpad[ipad]->Eval(x);
750  overlap[ipad] += prod;
751  //cout << " ipad " << ipad << " fpad " << fpad[ipad]->Eval(x) << " prod " << prod << " overlap[ipad] " << overlap[ipad] << endl;
752  }
753  } // pads
754 
755  } // steps
756 
757  // now we have the overlap for each pad
758  for(int ipad = 0;ipad <= npads;ipad++)
759  {
760  pad_phibin.push_back(pad_keep[ipad]);
761  pad_phibin_share.push_back(overlap[ipad]);
762  if(verbosity > 5000) cout << " zigzags: for pad " << ipad << " integral is " << overlap[ipad] << endl;
763  }
764 
765  return;
766 
767 }
768 
769 void PHG4CylinderCellTPCReco::populate_zbins(PHG4CylinderCellGeom *geo, const double z, const double cloud_sig_zz[2], std::vector<int> &adc_zbin, std::vector<double> &adc_zbin_share)
770 {
771  int zbin = geo->get_zbin(z); // z is (z + zsegoffset)
772  int nzbins = geo->get_zbins();
773 
774  double zstepsize = geo->get_zstep();
775  double zdisp = z - geo->get_zcenter(zbin);
776 
777  int min_cell_zbin = 0;
778  int max_cell_zbin = nzbins-1;
779  if (z>0)
780  {
781  min_cell_zbin = nzbins/2; //positive drifting volume
782  }
783  else
784  {
785  max_cell_zbin = nzbins/2 - 1; //negative drifting volume
786  }
787 
788  double cloud_sig_zz_inv[2];
789  cloud_sig_zz_inv[0] = 1. / cloud_sig_zz[0];
790  cloud_sig_zz_inv[1] = 1. / cloud_sig_zz[1];
791 
792  int n_zz = int(3 * (cloud_sig_zz[0] + cloud_sig_zz[1]) / (2.0 * zstepsize) + 1);
793  for (int iz = -n_zz; iz != n_zz + 1; ++iz)
794  {
795  int cur_z_bin = zbin + iz;
796  if ((cur_z_bin < min_cell_zbin) || (cur_z_bin > max_cell_zbin)) continue;
797  // Get the integral of the charge probability distribution in Z inside the current Z step. We only need to get the relative signs correct here, I think
798  // this is correct for z further from the membrane - charge arrives early
799  double zLim1 = 0.5 * M_SQRT2 * ((iz + 0.5) * zstepsize - zdisp) * cloud_sig_zz_inv[0];
800  double zLim2 = 0.5 * M_SQRT2 * ((iz - 0.5) * zstepsize - zdisp) * cloud_sig_zz_inv[0];
801  // The above is correct if we are in the leading part of the time distribution. In the tail of the distribution we use the second gaussian width
802  // this is correct for z closer to the membrane - charge arrives late
803  if (zLim1 > 0)
804  zLim1 = 0.5 * M_SQRT2 * ((iz + 0.5) * zstepsize - zdisp) * cloud_sig_zz_inv[1];
805  if (zLim2 > 0)
806  zLim2 = 0.5 * M_SQRT2 * ((iz - 0.5) * zstepsize - zdisp) * cloud_sig_zz_inv[1];
807  // 1/2 * the erf is the integral probability from the argument Z value to zero, so this is the integral probability between the Z limits
808  double z_integral = 0.5 * (erf(zLim1) - erf(zLim2));
809 
810  if(verbosity > 5000)
811  cout << " populate_zbins: cur_z_bin " << cur_z_bin << " center z " << geo->get_zcenter(cur_z_bin)
812  << " zLim1 " << zLim1 << " zLim2 " << zLim2 << " z_integral " << z_integral << endl;
813 
814  adc_zbin.push_back(cur_z_bin);
815  adc_zbin_share.push_back(z_integral);
816  }
817 
818  return;
819 }
static const double c_light
#define NULL
Definition: Pdb.h:9
int verbosity
The verbosity level. 0 means not verbose at all.
Definition: Fun4AllBase.h:75
virtual const std::string Name() const
Returns the name of this module.
Definition: Fun4AllBase.h:23
static Fun4AllServer * instance()
virtual bool registerHisto(const char *hname, TNamed *h1d, const int replace=0)
PHBoolean addNode(PHNode *)
ConstIterator AddCell(PHG4Cell *newCell)
virtual void add_shower_edep(const int g4showerid, const float edep)
Definition: PHG4Cell.h:48
virtual void add_edep(const PHG4HitDefs::keytype g4hitid, const float edep)
Definition: PHG4Cell.h:45
specialized cells for TPC operations
Definition: PHG4Cellv2.h:16
PHG4CylinderCellGeom * GetLayerCellGeom(const int i)
int AddLayerCellGeom(const int i, PHG4CylinderCellGeom *mygeom)
void set_zmin(const double z)
void set_radius(const double r)
virtual int get_phibin(const double phi) const
virtual double get_phicenter(const int ibin) const
void set_zstep(const double z)
void set_binning(const int i)
void set_layer(const int i)
void set_phibins(const int i)
void set_phistep(const double phi)
virtual double get_zcenter(const int ibin) const
void set_zbins(const int i)
double get_thickness() const
void set_thickness(const double t)
virtual int get_zbin(const double z) const
std::map< int, int > binning
std::vector< double > adc_zbin_share
void OutputDetector(const std::string &d)
gsl_rng * RandomGenerator
random generator that conform with sPHENIX standard
int InitRun(PHCompositeNode *topNode)
std::map< int, std::pair< double, double > > cell_size
std::map< int, std::pair< double, double > > tmin_max
std::vector< double > pad_phibin_share
void populate_zbins(PHG4CylinderCellGeom *geo, const double z, const double cloud_sig_zz[2], std::vector< int > &pad_zbin, std::vector< double > &pad_zbin_share)
int process_event(PHCompositeNode *topNode)
event processing
PHG4CylinderCellTPCReco(const int n_pixel=2, const std::string &name="CYLINDERTPCRECO")
void cellsize(const int i, const double sr, const double sz)
void populate_zigzag_phibins(PHG4CylinderCellGeom *geo, const double phi, const double cloud_sig_rp, std::vector< int > &pad_phibin, std::vector< double > &pad_phibin_share)
PHG4TPCDistortion * distortion
distortion to the primary ionization if not NULL
void populate_rectangular_phibins(PHG4CylinderCellGeom *geo, const double phi, const double cloud_sig_rp, std::vector< int > &pad_phibin, std::vector< double > &pad_phibin_share)
int Init(PHCompositeNode *topNode)
module initialization
std::map< int, double > phistep
void Detector(const std::string &d)
std::map< int, std::pair< int, int > > n_phi_z_bins
std::pair< std::map< int, PHG4CylinderGeom * >::const_iterator, std::map< int, PHG4CylinderGeom * >::const_iterator > get_begin_end() const
virtual double get_zmax() const
virtual int get_layer() const
virtual double get_thickness() const
virtual double get_radius() const
virtual double get_zmin() const
Map::const_iterator ConstIterator
std::set< unsigned int >::const_iterator LayerIter
std::pair< LayerIter, LayerIter > getLayers() const
ConstRange getHits(const unsigned int detid) const
return all hits matching a given detid
std::pair< ConstIterator, ConstIterator > ConstRange
PHNode * findFirst(const std::string &, const std::string &)
PHTimer * get(void)
Definition: PHTimeServer.h:43
PHTimer server for accessing external information.
Definition: PHTimeServer.h:29
void restart()
Restart timer.
Definition: PHTimer.h:70
void stop()
stops the counter
Definition: PHTimer.h:61
unsigned short int get_zbin(const PHG4CellDefs::keytype key)
Definition: PHG4CellDefs.cc:36
unsigned short int get_phibin(const PHG4CellDefs::keytype key)
Definition: PHG4CellDefs.cc:29
keytype genkey(const unsigned short layer, const unsigned short zbin, const unsigned short iphibin)
Definition: PHG4CellDefs.cc:22
unsigned long long keytype
Definition: PHG4CellDefs.h:7
#define PHWHERE
Definition: phool.h:23