CMS 3D CMS Logo

HFGflash.cc
Go to the documentation of this file.
2 
3 #include "G4VPhysicalVolume.hh"
4 #include "G4Step.hh"
5 #include "G4Track.hh"
6 #include "G4Navigator.hh"
7 #include "G4NavigationHistory.hh"
8 #include "CLHEP/Units/PhysicalConstants.h"
9 #include "CLHEP/Units/SystemOfUnits.h"
10 
11 #include "Randomize.hh"
12 #include "G4TransportationManager.hh"
13 #include "G4VPhysicalVolume.hh"
14 #include "G4LogicalVolume.hh"
15 #include "G4VSensitiveDetector.hh"
16 #include "G4EventManager.hh"
17 #include "G4SteppingManager.hh"
18 #include "G4FastTrack.hh"
19 #include "G4ParticleTable.hh"
20 
21 #include "CLHEP/GenericFunctions/IncompleteGamma.hh"
22 
26 
29 
30 #include "CLHEP/Units/GlobalPhysicalConstants.h"
31 #include "CLHEP/Units/GlobalSystemOfUnits.h"
32 
33 #include <cmath>
34 
35 //#define DebugLog
36 
38 
39  edm::ParameterSet m_HF = p.getParameter<edm::ParameterSet>("HFGflash");
40  theBField = m_HF.getUntrackedParameter<double>("BField", 3.8);
41  theWatcherOn = m_HF.getUntrackedParameter<bool>("WatcherOn",true);
42  theFillHisto = m_HF.getUntrackedParameter<bool>("FillHisto",true);
43  edm::LogInfo("HFShower") << "HFGFlash:: Set B-Field to " << theBField
44  << ", WatcherOn to " << theWatcherOn
45  << " and FillHisto to " << theFillHisto;
46 
48  theGflashStep = new G4Step();
49  theGflashNavigator = new G4Navigator();
50  // theGflashNavigator = 0;
51  theGflashTouchableHandle = new G4TouchableHistory();
52 
53 #ifdef DebugLog
54  if (theFillHisto) {
56  if ( tfile.isAvailable() ) {
57  TFileDirectory showerDir = tfile->mkdir("GflashEMShowerProfile");
58 
59  em_incE = showerDir.make<TH1F>("em_incE","Incoming energy (GeV)",500,0,500.);
60  em_ssp_rho = showerDir.make<TH1F>("em_ssp_rho","Shower starting position;#rho (cm);Number of Events",100,100.0,200.0);
61  em_ssp_z = showerDir.make<TH1F>("em_ssp_z","Shower starting position;z (cm);Number of Events",2000,0.0,2000.0);
62  em_long = showerDir.make<TH1F>("em_long","Longitudinal Profile;Radiation Length;Number of Spots",800,800.0,1600.0);
63  em_lateral = showerDir.make<TH1F>("em_lateral","Lateral Profile;Radiation Length;Moliere Radius",100,0.0,5.0);
64  em_2d = showerDir.make<TH2F>("em_2d","Lateral Profile vs. Shower Depth;Radiation Length;Moliere Radius",800,800.0,1600.0,100,0.0,5.0);
65  em_long_sd = showerDir.make<TH1F>("em_long_sd","Longitudinal Profile in Sensitive Detector;Radiation Length;Number of Spots",800,800.0,1600.0);
66  em_lateral_sd = showerDir.make<TH1F>("em_lateral_sd","Lateral Profile vs. Shower Depth in Sensitive Detector;Radiation Length;Moliere Radius",100,0.0,5.0);
67  em_2d_sd = showerDir.make<TH2F>("em_2d_sd","Lateral Profile vs. Shower Depth in Sensitive Detector;Radiation Length;Moliere Radius",800,800.0,1600.0,100,0.0,5.0);
68  em_ze = showerDir.make<TH2F>("em_ze","Profile vs. Energy;Radiation Length;Moliere Radius",800,800.0,1600.0,1000,0.0,1.0);
69  em_ratio = showerDir.make<TH2F>("em_ratio","Profile vs. Energy;Radiation Length;Moliere Radius",800,800.0,1600.0,1000,0.0,100.0);
70  em_ratio_selected = showerDir.make<TH2F>("em_ratio_selected","Profile vs. Energy;Radiation Length;Moliere Radius",800,800.0,1600.0,1000,0.0,100.0);
71  em_nSpots_sd = showerDir.make<TH1F>("em_nSpots_sd","Number of Gflash Spots in Sensitive Detector;Number of Spots;Number of Events",100,0.0,100);
72  em_ze_ratio = showerDir.make<TH1F>("em_ze_ratio","Ratio of Energy and Z Position",1000,0.0,0.001);
73  } else {
74  theFillHisto = false;
75  edm::LogInfo("HFShower") << "HFGFlash::No file is available for saving"
76  << " histos so the flag is set to false";
77  }
78  }
79 #endif
81 
82 }
83 
85  if (theHelix) delete theHelix;
86  if (theGflashStep) delete theGflashStep;
88 }
89 
90 
91 std::vector<HFGflash::Hit> HFGflash::gfParameterization(G4Step * aStep,bool & ok,bool onlyLong) {
92  double tempZCalo = 26; // Gflash::Z[jCalorimeter]
93  double hfcriticalEnergy = 0.021; // Gflash::criticalEnergy
94 
95  std::vector<HFGflash::Hit> hit;
96  HFGflash::Hit oneHit;
97 
98  G4StepPoint * preStepPoint = aStep->GetPreStepPoint();
99  G4Track * track = aStep->GetTrack();
100  G4String partType = track->GetDefinition()->GetParticleName();
101 
102  // This part of code is copied from the original GFlash Fortran code.
103  // reference : hep-ex/0001020v1
104 
105  const G4double energyCutoff = 1;
106  const G4int maxNumberOfSpots = 10000000;
107 
108  G4ThreeVector showerStartingPosition = track->GetPosition()/cm;
109  G4ThreeVector showerMomentum = preStepPoint->GetMomentum()/GeV;
111 
112  G4double logEinc = std::log((preStepPoint->GetTotalEnergy())/GeV);
113 
114  G4double y = ((preStepPoint->GetTotalEnergy())/GeV) / hfcriticalEnergy; // y = E/Ec, criticalEnergy is in GeV
115  G4double logY = std::log(y);
116 
117 
118  G4double nSpots = 93.0 * std::log(tempZCalo) * ((preStepPoint->GetTotalEnergy())/GeV); // total number of spot due linearization
119  if(preStepPoint->GetTotalEnergy()/GeV < 1.6) nSpots = 140.4 * std::log(tempZCalo) * std::pow(((preStepPoint->GetTotalEnergy())/GeV),0.876);
120 
121 
122  // // implementing magnetic field effects
123  double charge = track->GetStep()->GetPreStepPoint()->GetCharge();
124  theHelix->initializeTrajectory(showerMomentum,showerStartingPosition,charge,theBField);
125 
126  G4double pathLength0 = theHelix->getPathLengthAtZ(showerStartingPosition.getZ());
127  G4double pathLength = pathLength0; // this will grow along the shower development
128 
129  //--- 2.2 Fix intrinsic properties of em. showers.
130 
131  G4double fluctuatedTmax = std::log(logY - 0.7157);
132  G4double fluctuatedAlpha= std::log(0.7996 +(0.4581 + 1.8628/tempZCalo)*logY);
133 
134  G4double sigmaTmax = 1.0/( -1.4 + 1.26 * logY);
135  G4double sigmaAlpha = 1.0/( -0.58 + 0.86 * logY);
136  G4double rho = 0.705 - 0.023 * logY;
137  G4double sqrtPL = std::sqrt((1.0+rho)/2.0);
138  G4double sqrtLE = std::sqrt((1.0-rho)/2.0);
139 
140  G4double norm1 = G4RandGauss::shoot();
141  G4double norm2 = G4RandGauss::shoot();
142  G4double tempTmax = fluctuatedTmax + sigmaTmax*(sqrtPL*norm1 + sqrtLE*norm2);
143  G4double tempAlpha = fluctuatedAlpha + sigmaAlpha*(sqrtPL*norm1 - sqrtLE*norm2);
144 
145  // tmax, alpha, beta : parameters of gamma distribution
146  G4double tmax = std::exp(tempTmax);
147  G4double alpha = std::exp(tempAlpha);
148  G4double beta = (alpha - 1.0)/tmax;
149 
150  if (!alpha) return hit;
151  if (!beta) return hit;
152  if (alpha < 0.00001) return hit;
153  if (beta < 0.00001) return hit;
154 
155  // spot fluctuations are added to tmax, alpha, beta
156  G4double averageTmax = logY-0.858;
157  G4double averageAlpha = 0.21+(0.492+2.38/tempZCalo)*logY;
158  G4double spotTmax = averageTmax * (0.698 + .00212*tempZCalo);
159  G4double spotAlpha= averageAlpha * (0.639 + .00334*tempZCalo);
160  G4double spotBeta = (spotAlpha-1.0)/spotTmax;
161 
162  if (!spotAlpha) return hit;
163  if (!spotBeta) return hit;
164  if (spotAlpha < 0.00001) return hit;
165  if (spotBeta < 0.00001) return hit;
166 
167 #ifdef DebugLog
168  LogDebug("HFShower") << "Incoming energy = " << ((preStepPoint->GetTotalEnergy())/GeV) << " Position (rho,z) = (" << showerStartingPosition.rho() << ", " << showerStartingPosition.z() << ")";
169 
170  if(theFillHisto) {
171  em_incE->Fill(((preStepPoint->GetTotalEnergy())/GeV));
172  em_ssp_rho->Fill(showerStartingPosition.rho());
173  em_ssp_z->Fill(std::abs(showerStartingPosition.z()));
174  }
175 #endif
176  // parameters for lateral distribution and fluctuation
177  G4double z1=0.0251+0.00319*logEinc;
178  G4double z2=0.1162-0.000381*tempZCalo;
179 
180  G4double k1=0.659 - 0.00309 * tempZCalo;
181  G4double k2=0.645;
182  G4double k3=-2.59;
183  G4double k4=0.3585+ 0.0421*logEinc;
184 
185  G4double p1=2.623 -0.00094*tempZCalo;
186  G4double p2=0.401 +0.00187*tempZCalo;
187  G4double p3=1.313 -0.0686*logEinc;
188 
189  // // @@@ dwjang, intial tuning by comparing 20-150GeV TB data
190  // // the width of energy response is not yet tuned.
191  G4double e25Scale = 1.03551;
192  z1 *= 9.76972e-01 - 3.85026e-01 * std::tanh(1.82790e+00*std::log(((preStepPoint->GetTotalEnergy())/GeV)) - 3.66237e+00);
193  p1 *= 0.96;
194 
195  G4double stepLengthLeft = 10000;
196  G4int nSpots_sd = 0; // count total number of spots in SD
197  G4double zInX0 = 0.0; // shower depth in X0 unit
198  G4double deltaZInX0 = 0.0; // segment of depth in X0 unit
199  G4double deltaZ = 0.0; // segment of depth in cm
200  G4double stepLengthLeftInX0 = 0.0; // step length left in X0 unit
201 
202  const G4double divisionStepInX0 = 0.1; //step size in X0 unit
203  G4double energy = ((preStepPoint->GetTotalEnergy())/GeV); // energy left in GeV
204 
205  Genfun::IncompleteGamma gammaDist;
206 
207  G4double energyInGamma = 0.0; // energy in a specific depth(z) according to Gamma distribution
208  G4double preEnergyInGamma = 0.0; // energy calculated in a previous depth
209  G4double sigmaInGamma = 0.; // sigma of energy in a specific depth(z) according to Gamma distribution
210  G4double preSigmaInGamma = 0.0; // sigma of energy in a previous depth
211 
212  //energy segment in Gamma distribution of shower in each step
213  G4double deltaEnergy =0.0 ; // energy in deltaZ
214  G4int spotCounter = 0; // keep track of number of spots generated
215 
216  //step increment along the shower direction
217  G4double deltaStep = 0.0;
218 
219  // Uniqueness of G4Step is important otherwise hits won't be created.
220  G4double timeGlobal = track->GetStep()->GetPreStepPoint()->GetGlobalTime();
221 
222  // this needs to be deleted manually at the end of this loop.
223  // theGflashNavigator = new G4Navigator();
224  theGflashNavigator->SetWorldVolume(G4TransportationManager::GetTransportationManager()->GetNavigatorForTracking()->GetWorldVolume());
225 
226  // // loop for longitudinal integration
227 
228 #ifdef DebugLog
229  LogDebug("HFShower") << " Energy = " << energy << " Step Length Left = " << stepLengthLeft;
230 #endif
231  while(energy > 0.0 && stepLengthLeft > 0.0) {
232  stepLengthLeftInX0 = stepLengthLeft / Gflash::radLength[jCalorimeter];
233 
234  if ( stepLengthLeftInX0 < divisionStepInX0 ) {
235  deltaZInX0 = stepLengthLeftInX0;
236  deltaZ = deltaZInX0 * Gflash::radLength[jCalorimeter];
237  stepLengthLeft = 0.0;
238  } else {
239  deltaZInX0 = divisionStepInX0;
240  deltaZ = deltaZInX0 * Gflash::radLength[jCalorimeter];
241  stepLengthLeft -= deltaZ;
242  }
243 
244  zInX0 += deltaZInX0;
245 
246 #ifdef DebugLog
247  LogDebug("HFShower") << " zInX0 = " << zInX0 << " spotBeta*zInX0 = " << spotBeta*zInX0;
248 #endif
249  if ((!zInX0) || (! (spotBeta*zInX0 != 0) ) || (zInX0 < 0.01) ||
250  (spotBeta*zInX0 < 0.00001) || (! (zInX0*beta != 0) ) || (zInX0*beta < 0.00001))
251  return hit;
252 
253  G4int nSpotsInStep = 0;
254 
255 #ifdef DebugLog
256  LogDebug("HFShower") << " Energy - Energy Cut off = " << energy - energyCutoff;
257 #endif
258 
259  if ( energy > energyCutoff ) {
260  preEnergyInGamma = energyInGamma;
261  gammaDist.a().setValue(alpha); //alpha
262 
263  energyInGamma = gammaDist(beta*zInX0); //beta
264  G4double energyInDeltaZ = energyInGamma - preEnergyInGamma;
265  deltaEnergy = std::min(energy,((preStepPoint->GetTotalEnergy())/GeV)*energyInDeltaZ);
266 
267  preSigmaInGamma = sigmaInGamma;
268  gammaDist.a().setValue(spotAlpha); //alpha spot
269  sigmaInGamma = gammaDist(spotBeta*zInX0); //beta spot
270  nSpotsInStep = std::max(1,int(nSpots * (sigmaInGamma - preSigmaInGamma)));
271  } else {
272  deltaEnergy = energy;
273  preSigmaInGamma = sigmaInGamma;
274  nSpotsInStep = std::max(1,int(nSpots * (1.0 - preSigmaInGamma)));
275  }
276 
277  if ( deltaEnergy > energy || (energy-deltaEnergy) < energyCutoff ) deltaEnergy = energy;
278 
279  energy -= deltaEnergy;
280 
281  if ( spotCounter+nSpotsInStep > maxNumberOfSpots ) {
282  nSpotsInStep = maxNumberOfSpots - spotCounter;
283  if (nSpotsInStep < 1) nSpotsInStep = 1;
284  }
285 
286 
287  // // It begins with 0.5 of deltaZ and then icreases by 1 deltaZ
288  deltaStep += 0.5*deltaZ;
289  pathLength += deltaStep;
290  deltaStep = 0.5*deltaZ;
291 
292 
293  //lateral shape and fluctuations for homogenous calo.
294  G4double tScale = tmax *alpha/(alpha-1.0) * (std::exp(fluctuatedAlpha)-1.0)/std::exp(fluctuatedAlpha);
295  G4double tau = std::min(10.0,(zInX0 - 0.5*deltaZInX0)/tScale);
296  G4double rCore = z1 + z2 * tau;
297  G4double rTail = k1 *( std::exp(k3*(tau-k2)) + std::exp(k4*(tau-k2))); // @@ check RT3 sign
298  G4double p23 = (p2 - tau)/p3;
299  G4double probabilityWeight = p1 * std::exp( p23 - std::exp(p23) );
300 
301 
302  // Deposition of spots according to lateral distr.
303  // Apply absolute energy scale
304  // Convert into MeV unit
305  G4double emSpotEnergy = deltaEnergy / nSpotsInStep * e25Scale * GeV;
306 
307 
308 #ifdef DebugLog
309  LogDebug("HFShower") << " nSpotsInStep = " << nSpotsInStep;
310 #endif
311 
312 
313 
314  for (G4int ispot = 0 ; ispot < nSpotsInStep ; ispot++) {
315  spotCounter++;
316  G4double u1 = G4UniformRand();
317  G4double u2 = G4UniformRand();
318  G4double rInRM = 0.0;
319 
320  if (u1 < probabilityWeight) {
321  rInRM = rCore * std::sqrt( u2/(1.0-u2) );
322  } else {
323  rInRM = rTail * std::sqrt( u2/(1.0-u2) );
324  }
325 
326  G4double rShower = rInRM * Gflash::rMoliere[jCalorimeter];
327 
328  //Uniform & random rotation of spot along the azimuthal angle
329  G4double azimuthalAngle = twopi*G4UniformRand();
330 
331  //Compute global position of generated spots with taking into account magnetic field
332  //Divide deltaZ into nSpotsInStep and give a spot a global position
333  G4double incrementPath = (deltaZ/nSpotsInStep)*(ispot+0.5 - 0.5*nSpotsInStep);
334 
335  // trajectoryPoint give a spot an imaginary point along the shower development
336  GflashTrajectoryPoint trajectoryPoint;
337  theHelix->getGflashTrajectoryPoint(trajectoryPoint,pathLength+incrementPath);
338 
339 
340  G4ThreeVector SpotPosition0 = trajectoryPoint.getPosition() + rShower*std::cos(azimuthalAngle)*trajectoryPoint.getOrthogonalUnitVector() + rShower*std::sin(azimuthalAngle)*trajectoryPoint.getCrossUnitVector();
341 
343  // Convert into mm unit
344  SpotPosition0 *= cm;
345 
346 
347  //---------------------------------------------------
348  // fill a fake step to send it to hit maker
349  //---------------------------------------------------
350 
351  // to make a different time for each fake step. (0.03 nsec is corresponding to 1cm step size)
352  timeGlobal += 0.0001*nanosecond;
353 
354  //fill equivalent changes to a (fake) step associated with a spot
355 
356  G4double zInX0_spot = std::abs(pathLength+incrementPath - pathLength0)/Gflash::radLength[jCalorimeter];
357 
358 #ifdef DebugLog
359  LogDebug("HFShower") << "zInX0_spot,emSpotEnergy/GeV =" << zInX0_spot << " , " << emSpotEnergy/GeV << "emSpotEnergy/GeV =" << emSpotEnergy/GeV;
360 #endif
361 
362  if ((!zInX0_spot) || (zInX0_spot < 0)) continue;
363  if ((!emSpotEnergy/GeV) || (emSpotEnergy < 0)) continue;
364  if ((!rShower/Gflash::rMoliere[jCalorimeter]) || (rShower/Gflash::rMoliere[jCalorimeter] < 0)) continue;
365 
366  oneHit.depth = 1;
367 
368 #ifdef DebugLog
369  if (theFillHisto) {
370  em_long->Fill(SpotPosition0.z()/cm,emSpotEnergy/GeV);
371  em_lateral->Fill(rShower/Gflash::rMoliere[jCalorimeter],emSpotEnergy/GeV);
372  em_2d->Fill(SpotPosition0.z()/cm,rShower/Gflash::rMoliere[jCalorimeter],emSpotEnergy/GeV);
373  }
374 #endif
375 
377  //if(SpotPosition0 == 0) continue;
378 
379  double energyratio = emSpotEnergy/(preStepPoint->GetTotalEnergy()/(nSpots*e25Scale));
380 
381  if (emSpotEnergy/GeV < 0.0001) continue;
382  if (energyratio > 80) continue;
383 
384  double zshift =0;
385  if(SpotPosition0.z() > 0) zshift = 18;
386  if(SpotPosition0.z() < 0) zshift = -18;
387 
388 
389  G4ThreeVector gfshift(0,0,zshift*(pow(100,0.1)/pow(preStepPoint->GetTotalEnergy()/GeV,0.1)));
390 
391  G4ThreeVector SpotPosition = gfshift + SpotPosition0;
392 
393  double LengthWeight = std::fabs(std::pow(SpotPosition0.z()/11370,1));
394  if (G4UniformRand()> 0.0021 * energyratio * LengthWeight) continue;
395 
396  oneHit.position = SpotPosition;
397  oneHit.time = timeGlobal;
398  oneHit.edep = emSpotEnergy/GeV;
399  hit.push_back(oneHit);
400  nSpots_sd++;
401 
402  } // end of for spot iteration
403 
404  } // end of while for longitudinal integration
405 #ifdef DebugLog
406  if (theFillHisto) {
407  em_nSpots_sd->Fill(nSpots_sd);
408  }
409 #endif
410  // delete theGflashNavigator;
411  return hit;
412 }
#define LogDebug(id)
const double beta
std::vector< Hit > gfParameterization(G4Step *aStep, bool &ok, bool onlyLong=false)
Definition: HFGflash.cc:91
virtual ~HFGflash()
Definition: HFGflash.cc:84
T getParameter(std::string const &) const
G4Step * theGflashStep
Definition: HFGflash.h:50
T getUntrackedParameter(std::string const &, T const &) const
TH2F * em_ze
Definition: HFGflash.h:69
G4Navigator * theGflashNavigator
Definition: HFGflash.h:51
float alpha
Definition: AMPTWrapper.h:95
const double GeV
Definition: MathUtil.h:16
double getPathLengthAtZ(double z) const
Gflash3Vector getCrossUnitVector()
TH1F * em_ssp_z
Definition: HFGflash.h:67
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
Gflash::CalorimeterNumber jCalorimeter
Definition: HFGflash.h:54
G4double theBField
Definition: HFGflash.h:58
bool theFillHisto
Definition: HFGflash.h:57
const double rMoliere[kNumberCalorimeter]
T sqrt(T t)
Definition: SSEVec.h:18
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
TH2F * em_ratio_selected
Definition: HFGflash.h:69
bool isAvailable() const
Definition: Service.h:46
G4TouchableHandle theGflashTouchableHandle
Definition: HFGflash.h:52
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
double edep
Definition: HFGflash.h:41
T * make(const Args &...args) const
make new ROOT object
T min(T a, T b)
Definition: MathUtil.h:58
bool theWatcherOn
Definition: HFGflash.h:56
double p2[4]
Definition: TauolaWrapper.h:90
TH2F * em_ratio
Definition: HFGflash.h:69
TH1F * em_ze_ratio
Definition: HFGflash.h:68
HFGflash(edm::ParameterSet const &p)
Definition: HFGflash.cc:37
Gflash3Vector getOrthogonalUnitVector()
void getGflashTrajectoryPoint(GflashTrajectoryPoint &point, double s) const
static const double tmax[3]
TH1F * em_ssp_rho
Definition: HFGflash.h:67
const double radLength[kNumberCalorimeter]
TFileDirectory mkdir(const std::string &dir, const std::string &descr="")
create a new subdirectory
Definition: TFileService.h:69
double time
Definition: HFGflash.h:40
TH1F * em_lateral_sd
Definition: HFGflash.h:68
TH1F * em_nSpots_sd
Definition: HFGflash.h:68
TH1F * em_lateral
Definition: HFGflash.h:67
TH1F * em_long
Definition: HFGflash.h:67
Gflash3Vector & getPosition()
double p1[4]
Definition: TauolaWrapper.h:89
G4ThreeVector position
Definition: HFGflash.h:38
TH1F * em_incE
Definition: HFGflash.h:67
GflashTrajectory * theHelix
Definition: HFGflash.h:49
TH1F * em_long_sd
Definition: HFGflash.h:68
TH2F * em_2d
Definition: HFGflash.h:69
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:40
double p3[4]
Definition: TauolaWrapper.h:91
TH2F * em_2d_sd
Definition: HFGflash.h:69
void initializeTrajectory(const HepGeom::Vector3D< double > &, const HepGeom::Point3D< double > &, double q, double Field)