10 #include "PHG4TPCDistortion.h"
26 #include <TProfile2D.h>
30 #include <CLHEP/Units/PhysicalConstants.h>
31 #include <CLHEP/Units/SystemOfUnits.h>
33 #include <gsl/gsl_randist.h>
51 , elec_per_gev(38. * 1e6)
52 , driftv(3.0 / 1000.0)
53 , fpad{nullptr,nullptr,nullptr,nullptr,nullptr,nullptr,nullptr,nullptr,nullptr,nullptr}
56 num_pixel_layers(n_pixel)
66 , fHMeanEDepPerCell(
NULL)
67 , fHMeanElectronsPerCell(
NULL)
72 , fShapingLead(32.0 * 3.0 / 1000.0)
74 fShapingTail(48.0 * 3.0 / 1000.0)
79 cout <<
Name() <<
" random seed: " << seed << endl;
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);
139 std::cout <<
PHWHERE <<
"DST Node missing, doing nothing." << std::endl;
146 cout <<
"Could not locate g4 hit node " <<
hitnodename << endl;
161 cout <<
"Could not locate geometry node " <<
geonodename << endl;
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)
181 double circumference = layergeom->
get_radius() * 2 * M_PI;
186 cout <<
"no cell sizes for layer " << layer << endl;
194 double size_z = (sizeiter->second).second;
195 double size_r = (sizeiter->second).first;
200 double fract = modf(circumference / size_r, &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;
212 for (
int i = 0; i <
nbins[0]; i++)
214 phimax += phistepsize;
219 fract = modf(length_in_z / size_z, &bins_r);
225 pair<int, int> phi_z_bin = make_pair(
nbins[0],
nbins[1]);
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;
233 for (
int i = 0; i <
nbins[1]; i++)
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;
256 for (std::map<int, int>::iterator iter =
binning.begin();
259 int layer = iter->first;
264 fcharge =
new TF1(
"fcharge",
"gaus(0)");
266 for(
int ipad = 0;ipad < 10; ipad++)
269 sprintf(name,
"fpad%i",ipad);
270 fpad[ipad] =
new TF1(name,
"[0]-abs(x-[1])");
273 cout <<
"The TPC zigzag pad option is set to " <<
zigzag_pads << endl;
284 cout <<
"Could not locate g4 hit node " <<
hitnodename << endl;
290 cout <<
"could not locate cell node " <<
cellnodename << endl;
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++)
305 std::map<unsigned long long, PHG4Cell *> cellptmap;
311 std::cout <<
"Layer " << (*layer);
314 std::cout <<
" zmin " << geo->
get_zmin();
315 std::cout <<
" nbinsz " << geo->
get_zbins();
318 std::cout << std::endl;
327 cout <<
"logical screwup!!! no sizes for layer " << *layer << endl;
332 for (hiter = hit_begin_end.first; hiter != hit_begin_end.second; hiter++)
335 if (hiter->second->get_t(0) >
tmin_max[*layer].second)
continue;
336 if (hiter->second->get_t(1) <
tmin_max[*layer].first)
continue;
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();
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()
356 double truth_phi = phi;
365 const double dz =
distortion->get_z_distortion(r, phi, z);
366 const double drphi =
distortion->get_rphi_distortion(r, phi, z);
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);
381 z -=
driftv * (hiter->second->get_avg_t() - approximate_cluster_path_length / speed_of_light_cm_ns);
383 z +=
driftv * (hiter->second->get_avg_t() - approximate_cluster_path_length / speed_of_light_cm_ns);
386 if (phibin < 0 || phibin >= nphibins)
392 zbin = geo->
get_zbin(hiter->second->get_avg_z());
393 if (zbin < 0 || zbin >= nzbins)
399 double edep = hiter->second->get_edep();
404 if (
verbosity > 2000) cout <<
"Find or start a cell for this hit" << endl;
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);
412 if (it != cellptmap.end())
420 cellptmap[key] = cell;
430 float eion = hiter->second->get_eion();
454 double cloud_sig_zz[2];
462 if (phi > +M_PI) phi -= 2 * M_PI;
463 if (phi < -M_PI) phi += 2 * M_PI;
470 if (phibin < 0 || phibin >= nphibins)
474 if (zbin < 0 || zbin >= nzbins)
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;
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;
503 int nseg = (int)zrange/cloud_sig_zz[0];
504 if(nseg%2==0)nseg+=1;
506 for (
int izr = 0; izr < nseg; izr++)
508 double zsegoffset = (izr - nseg / 2) * zrange / nseg;
511 int zbinseg = zbin = geo->
get_zbin(z + zsegoffset);
512 if (zbinseg < 0 || zbinseg >= nzbins)
516 double zdispseg = z + zsegoffset - geo->
get_zcenter(zbinseg);
518 if (
verbosity > 2000) cout <<
" ---------- segment izr = " << izr <<
" with zsegoffset " << zsegoffset <<
" zbinseg " << zbinseg <<
" zdispseg " << zdispseg << endl;
535 for(
unsigned int ipad = 0; ipad <
pad_phibin.size(); ++ipad)
540 for(
unsigned int iphi = 0; iphi <
pad_phibin.size(); ++iphi)
551 for(
unsigned int iz = 0; iz <
adc_zbin.size(); ++iz)
556 for(
unsigned int iz = 0; iz <
adc_zbin.size(); ++iz)
562 double phi_integral = 0.0;
563 double z_integral = 0.0;
566 for(
unsigned int ipad = 0; ipad <
pad_phibin.size(); ++ipad)
571 for(
unsigned int iz = 0; iz<
adc_zbin.size(); ++iz)
577 float neffelectrons = (2000.0 / nseg) * nelec * (pad_share) * (adc_bin_share);
579 if (neffelectrons < 50)
continue;
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;
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;
593 phi_integral += phicenter*neffelectrons;
595 z_integral += zcenter*neffelectrons;
596 weight += neffelectrons;
598 std::map<unsigned long long, PHG4Cell *>::iterator it = cellptmap.find(key);
600 if (it != cellptmap.end())
608 cellptmap[key] = cell;
610 cell->
add_edep(hiter->first, neffelectrons);
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;
627 for (std::map<unsigned long long, PHG4Cell *>::iterator it = cellptmap.begin(); it != cellptmap.end(); ++it)
638 std::cout <<
" Adding phibin " << phibin <<
" zbin " << zbin <<
" with edep " << it->second->get_edep() << std::endl;
642 std::cout <<
" || Number of cells hit " << count << std::endl;
644 if (
verbosity > 1000) std::cout <<
"PHG4CylinderCellTPCReco end" << std::endl;
651 double cloud_sig_rp_inv = 1. / cloud_sig_rp;
661 int n_rp = int(3 * cloud_sig_rp / (radius * phistepsize) + 1);
662 for (
int iphi = -n_rp; iphi != n_rp + 1; ++iphi)
664 int cur_phi_bin = phibin + iphi;
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))
672 std::cout <<
"PHG4CylinderCellTPCReco => error in phi continuity. Skipping" << std::endl;
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));
690 double nsigmas = 5.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;
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;
716 for(
int ipad = 0; ipad<=npads;ipad++)
718 int pad_now = phibin_low + ipad;
722 pad_keep[ipad] = pad_now;
725 fpad[ipad]->SetParameter(0,pad_rphi/2.0);
726 fpad[ipad]->SetParameter(1, rphi_pad_now);
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;
735 for(
int i=0;i<10;i++)
739 double xstep = 2.0 * nsigmas * cloud_sig_rp / (double) nsteps;
740 for(
int i=0;i<nsteps;i++)
742 double x = rphi - 4.5 * cloud_sig_rp + (double) i * xstep;
743 double charge =
fcharge->Eval(x);
745 for(
int ipad = 0;ipad<=npads;ipad++)
747 if(
fpad[ipad]->Eval(x) > 0.0)
749 double prod = charge *
fpad[ipad]->Eval(x);
750 overlap[ipad] += prod;
758 for(
int ipad = 0;ipad <= npads;ipad++)
762 if(
verbosity > 5000) cout <<
" zigzags: for pad " << ipad <<
" integral is " << overlap[ipad] << endl;
777 int min_cell_zbin = 0;
778 int max_cell_zbin = nzbins-1;
781 min_cell_zbin = nzbins/2;
785 max_cell_zbin = nzbins/2 - 1;
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];
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)
795 int cur_z_bin = zbin + iz;
796 if ((cur_z_bin < min_cell_zbin) || (cur_z_bin > max_cell_zbin))
continue;
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];
804 zLim1 = 0.5 * M_SQRT2 * ((iz + 0.5) * zstepsize - zdisp) * cloud_sig_zz_inv[1];
806 zLim2 = 0.5 * M_SQRT2 * ((iz - 0.5) * zstepsize - zdisp) * cloud_sig_zz_inv[1];
808 double z_integral = 0.5 * (erf(zLim1) - erf(zLim2));
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;
int verbosity
The verbosity level. 0 means not verbose at all.
virtual const std::string Name() const
Returns the name of this module.
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)
virtual void add_edep(const PHG4HitDefs::keytype g4hitid, const float edep)
specialized cells for TPC operations
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)
double get_phistep() const
void set_binning(const int i)
void set_layer(const int i)
void set_phibins(const int i)
double get_radius() const
void set_phistep(const double phi)
virtual double get_zcenter(const int ibin) const
void set_zbins(const int i)
double get_thickness() const
double get_phimin() const
void set_thickness(const double t)
virtual int get_zbin(const double z) const
std::map< int, int > binning
std::vector< int > pad_phibin
std::vector< double > adc_zbin_share
PHTimeServer::timer _timer
void OutputDetector(const std::string &d)
TProfile2D * fHMeanEDepPerCell
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")
virtual ~PHG4CylinderCellTPCReco()
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
TProfile2D * fHMeanElectronsPerCell
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
std::string seggeonodename
void Detector(const std::string &d)
std::map< int, std::pair< int, int > > n_phi_z_bins
std::vector< int > adc_zbin
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 server for accessing external information.
void restart()
Restart timer.
void stop()
stops the counter
unsigned short int get_zbin(const PHG4CellDefs::keytype key)
unsigned short int get_phibin(const PHG4CellDefs::keytype key)
keytype genkey(const unsigned short layer, const unsigned short zbin, const unsigned short iphibin)
unsigned long long keytype