Geant4.10
 All Data Structures Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
G4MollerBhabhaModel.cc
Go to the documentation of this file.
1 //
2 // ********************************************************************
3 // * License and Disclaimer *
4 // * *
5 // * The Geant4 software is copyright of the Copyright Holders of *
6 // * the Geant4 Collaboration. It is provided under the terms and *
7 // * conditions of the Geant4 Software License, included in the file *
8 // * LICENSE and available at http://cern.ch/geant4/license . These *
9 // * include a list of copyright holders. *
10 // * *
11 // * Neither the authors of this software system, nor their employing *
12 // * institutes,nor the agencies providing financial support for this *
13 // * work make any representation or warranty, express or implied, *
14 // * regarding this software system or assume any liability for its *
15 // * use. Please see the license in the file LICENSE and URL above *
16 // * for the full disclaimer and the limitation of liability. *
17 // * *
18 // * This code implementation is the result of the scientific and *
19 // * technical work of the GEANT4 collaboration. *
20 // * By using, copying, modifying or distributing the software (or *
21 // * any work based on the software) you agree to acknowledge its *
22 // * use in resulting scientific publications, and indicate your *
23 // * acceptance of all terms of the Geant4 Software license. *
24 // ********************************************************************
25 //
26 // $Id: G4MollerBhabhaModel.cc 74790 2013-10-22 07:31:37Z gcosmo $
27 //
28 // -------------------------------------------------------------------
29 //
30 // GEANT4 Class file
31 //
32 //
33 // File name: G4MollerBhabhaModel
34 //
35 // Author: Vladimir Ivanchenko on base of Laszlo Urban code
36 //
37 // Creation date: 03.01.2002
38 //
39 // Modifications:
40 //
41 // 13-11-02 Minor fix - use normalised direction (V.Ivanchenko)
42 // 04-12-02 Change G4DynamicParticle constructor in PostStepDoIt (V.Ivanchenko)
43 // 23-12-02 Change interface in order to move to cut per region (V.Ivanchenko)
44 // 27-01-03 Make models region aware (V.Ivanchenko)
45 // 13-02-03 Add name (V.Ivanchenko)
46 // 08-04-05 Major optimisation of internal interfaces (V.Ivantchenko)
47 // 25-07-05 Add protection in calculation of recoil direction for the case
48 // of complete energy transfer from e+ to e- (V.Ivanchenko)
49 // 06-02-06 ComputeCrossSectionPerElectron, ComputeCrossSectionPerAtom (mma)
50 // 15-05-06 Fix MinEnergyCut (V.Ivanchenko)
51 //
52 //
53 // Class Description:
54 //
55 // Implementation of energy loss and delta-electron production by e+/e-
56 //
57 // -------------------------------------------------------------------
58 //
59 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
60 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
61 
62 #include "G4MollerBhabhaModel.hh"
63 #include "G4PhysicalConstants.hh"
64 #include "G4SystemOfUnits.hh"
65 #include "G4Electron.hh"
66 #include "G4Positron.hh"
67 #include "Randomize.hh"
69 #include "G4Log.hh"
70 #include "G4DeltaAngle.hh"
71 
72 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
73 
74 using namespace std;
75 
77  const G4String& nam)
78  : G4VEmModel(nam),
79  particle(0),
80  isElectron(true),
81  twoln10(2.0*G4Log(10.0)),
82  lowLimit(0.02*keV),
83  isInitialised(false)
84 {
86  if(p) { SetParticle(p); }
87  fParticleChange = 0;
88 }
89 
90 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
91 
93 {}
94 
95 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
96 
98  G4double kinEnergy)
99 {
100  G4double tmax = kinEnergy;
101  if(isElectron) { tmax *= 0.5; }
102  return tmax;
103 }
104 
105 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
106 
108  const G4DataVector&)
109 {
110  if(!particle) { SetParticle(p); }
111 
112  if(isInitialised) { return; }
113 
114  isInitialised = true;
118  }
119 }
120 
121 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
122 
123 G4double
125  G4double kineticEnergy,
126  G4double cutEnergy,
127  G4double maxEnergy)
128 {
129  if(!particle) { SetParticle(p); }
130 
131  G4double cross = 0.0;
132  G4double tmax = MaxSecondaryEnergy(p, kineticEnergy);
133  tmax = std::min(maxEnergy, tmax);
134 
135  if(cutEnergy < tmax) {
136 
137  G4double xmin = cutEnergy/kineticEnergy;
138  G4double xmax = tmax/kineticEnergy;
139  G4double tau = kineticEnergy/electron_mass_c2;
140  G4double gam = tau + 1.0;
141  G4double gamma2= gam*gam;
142  G4double beta2 = tau*(tau + 2)/gamma2;
143 
144  //Moller (e-e-) scattering
145  if (isElectron) {
146 
147  G4double gg = (2.0*gam - 1.0)/gamma2;
148  cross = ((xmax - xmin)*(1.0 - gg + 1.0/(xmin*xmax)
149  + 1.0/((1.0-xmin)*(1.0 - xmax)))
150  - gg*G4Log( xmax*(1.0 - xmin)/(xmin*(1.0 - xmax)) ) ) / beta2;
151 
152  //Bhabha (e+e-) scattering
153  } else {
154 
155  G4double y = 1.0/(1.0 + gam);
156  G4double y2 = y*y;
157  G4double y12 = 1.0 - 2.0*y;
158  G4double b1 = 2.0 - y2;
159  G4double b2 = y12*(3.0 + y2);
160  G4double y122= y12*y12;
161  G4double b4 = y122*y12;
162  G4double b3 = b4 + y122;
163 
164  cross = (xmax - xmin)*(1.0/(beta2*xmin*xmax) + b2
165  - 0.5*b3*(xmin + xmax)
166  + b4*(xmin*xmin + xmin*xmax + xmax*xmax)/3.0)
167  - b1*G4Log(xmax/xmin);
168  }
169 
170  cross *= twopi_mc2_rcl2/kineticEnergy;
171  }
172  return cross;
173 }
174 
175 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
176 
178  const G4ParticleDefinition* p,
179  G4double kineticEnergy,
180  G4double Z, G4double,
181  G4double cutEnergy,
182  G4double maxEnergy)
183 {
184  return Z*ComputeCrossSectionPerElectron(p,kineticEnergy,cutEnergy,maxEnergy);
185 }
186 
187 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
188 
190  const G4Material* material,
191  const G4ParticleDefinition* p,
192  G4double kinEnergy,
193  G4double cutEnergy,
194  G4double maxEnergy)
195 {
196  G4double eDensity = material->GetElectronDensity();
197  return eDensity*ComputeCrossSectionPerElectron(p,kinEnergy,cutEnergy,maxEnergy);
198  /*
199  G4double Zeff = eDensity/material->GetTotNbOfAtomsPerVolume();
200  G4double th = 0.25*sqrt(Zeff)*keV;
201  G4double cut;
202  if(isElectron) { cut = std::max(th*0.5, cutEnergy); }
203  else { cut = std::max(th, cutEnergy); }
204  G4double res = 0.0;
205  // below this threshold no bremsstrahlung
206  if (kinEnergy > th) {
207  res = eDensity*ComputeCrossSectionPerElectron(p,kinEnergy,cut,maxEnergy);
208  }
209  return res;
210  */
211 }
212 
213 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
214 
216  const G4Material* material,
217  const G4ParticleDefinition* p,
218  G4double kineticEnergy,
219  G4double cut)
220 {
221  if(!particle) { SetParticle(p); }
222  // calculate the dE/dx due to the ionization by Seltzer-Berger formula
223  // checl low-energy limit
224  G4double electronDensity = material->GetElectronDensity();
225 
226  G4double Zeff = electronDensity/material->GetTotNbOfAtomsPerVolume();
227  G4double th = 0.25*sqrt(Zeff)*keV;
228  // G4double cut;
229  // if(isElectron) { cut = std::max(th*0.5, cutEnergy); }
230  // else { cut = std::max(th, cutEnergy); }
231  G4double tkin = kineticEnergy;
232  if (kineticEnergy < th) { tkin = th; }
233 
234  G4double tau = tkin/electron_mass_c2;
235  G4double gam = tau + 1.0;
236  G4double gamma2= gam*gam;
237  G4double bg2 = tau*(tau + 2);
238  G4double beta2 = bg2/gamma2;
239 
240  G4double eexc = material->GetIonisation()->GetMeanExcitationEnergy();
241  eexc /= electron_mass_c2;
242  G4double eexc2 = eexc*eexc;
243 
245  G4double dedx;
246 
247  // electron
248  if (isElectron) {
249 
250  dedx = G4Log(2.0*(tau + 2.0)/eexc2) - 1.0 - beta2
251  + G4Log((tau-d)*d) + tau/(tau-d)
252  + (0.5*d*d + (2.0*tau + 1.)*G4Log(1. - d/tau))/gamma2;
253 
254  //positron
255  } else {
256 
257  G4double d2 = d*d*0.5;
258  G4double d3 = d2*d/1.5;
259  G4double d4 = d3*d*0.75;
260  G4double y = 1.0/(1.0 + gam);
261  dedx = G4Log(2.0*(tau + 2.0)/eexc2) + G4Log(tau*d)
262  - beta2*(tau + 2.0*d - y*(3.0*d2
263  + y*(d - d3 + y*(d2 - tau*d3 + d4))))/tau;
264  }
265 
266  //density correction
267  G4double x = G4Log(bg2)/twoln10;
268  dedx -= material->GetIonisation()->DensityCorrection(x);
269 
270  // now you can compute the total ionization loss
271  dedx *= twopi_mc2_rcl2*electronDensity/beta2;
272  if (dedx < 0.0) { dedx = 0.0; }
273 
274  // lowenergy extrapolation
275 
276  if (kineticEnergy < th) {
277  x = kineticEnergy/th;
278  if(x > 0.25) { dedx /= sqrt(x); }
279  else { dedx *= 1.4*sqrt(x)/(0.1 + x); }
280  }
281  return dedx;
282 }
283 
284 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
285 
286 void
287 G4MollerBhabhaModel::SampleSecondaries(std::vector<G4DynamicParticle*>* vdp,
288  const G4MaterialCutsCouple* couple,
289  const G4DynamicParticle* dp,
290  G4double cutEnergy,
291  G4double maxEnergy)
292 {
293  G4double kineticEnergy = dp->GetKineticEnergy();
294  //const G4Material* mat = couple->GetMaterial();
295  //G4double Zeff = mat->GetElectronDensity()/mat->GetTotNbOfAtomsPerVolume();
296  // G4double th = 0.25*sqrt(Zeff)*keV;
297  G4double tmax;
298  G4double tmin = cutEnergy;
299  if(isElectron) {
300  tmax = 0.5*kineticEnergy;
301  } else {
302  tmax = kineticEnergy;
303  }
304  if(maxEnergy < tmax) { tmax = maxEnergy; }
305  if(tmin >= tmax) { return; }
306 
307  G4double energy = kineticEnergy + electron_mass_c2;
308  G4double xmin = tmin/kineticEnergy;
309  G4double xmax = tmax/kineticEnergy;
310  G4double gam = energy/electron_mass_c2;
311  G4double gamma2 = gam*gam;
312  G4double beta2 = 1.0 - 1.0/gamma2;
313  G4double x, z, q, grej;
314 
315  //Moller (e-e-) scattering
316  if (isElectron) {
317 
318  G4double gg = (2.0*gam - 1.0)/gamma2;
319  G4double y = 1.0 - xmax;
320  grej = 1.0 - gg*xmax + xmax*xmax*(1.0 - gg + (1.0 - gg*y)/(y*y));
321 
322  do {
323  q = G4UniformRand();
324  x = xmin*xmax/(xmin*(1.0 - q) + xmax*q);
325  y = 1.0 - x;
326  z = 1.0 - gg*x + x*x*(1.0 - gg + (1.0 - gg*y)/(y*y));
327  /*
328  if(z > grej) {
329  G4cout << "G4MollerBhabhaModel::SampleSecondary Warning! "
330  << "Majorant " << grej << " < "
331  << z << " for x= " << x
332  << " e-e- scattering"
333  << G4endl;
334  }
335  */
336  } while(grej * G4UniformRand() > z);
337 
338  //Bhabha (e+e-) scattering
339  } else {
340 
341  G4double y = 1.0/(1.0 + gam);
342  G4double y2 = y*y;
343  G4double y12 = 1.0 - 2.0*y;
344  G4double b1 = 2.0 - y2;
345  G4double b2 = y12*(3.0 + y2);
346  G4double y122= y12*y12;
347  G4double b4 = y122*y12;
348  G4double b3 = b4 + y122;
349 
350  y = xmax*xmax;
351  grej = 1.0 + (y*y*b4 - xmin*xmin*xmin*b3 + y*b2 - xmin*b1)*beta2;
352  do {
353  q = G4UniformRand();
354  x = xmin*xmax/(xmin*(1.0 - q) + xmax*q);
355  y = x*x;
356  z = 1.0 + (y*y*b4 - x*y*b3 + y*b2 - x*b1)*beta2;
357  /*
358  if(z > grej) {
359  G4cout << "G4MollerBhabhaModel::SampleSecondary Warning! "
360  << "Majorant " << grej << " < "
361  << z << " for x= " << x
362  << " e+e- scattering"
363  << G4endl;
364  }
365  */
366  } while(grej * G4UniformRand() > z);
367  }
368 
369  G4double deltaKinEnergy = x * kineticEnergy;
370 
371  G4ThreeVector deltaDirection;
372 
374  const G4Material* mat = couple->GetMaterial();
375  G4int Z = SelectRandomAtomNumber(mat);
376 
377  deltaDirection =
378  GetAngularDistribution()->SampleDirection(dp, deltaKinEnergy, Z, mat);
379 
380  } else {
381 
382  G4double deltaMomentum =
383  sqrt(deltaKinEnergy * (deltaKinEnergy + 2.0*electron_mass_c2));
384  G4double cost = deltaKinEnergy * (energy + electron_mass_c2) /
385  (deltaMomentum * dp->GetTotalMomentum());
386  if(cost > 1.0) { cost = 1.0; }
387  G4double sint = sqrt((1.0 - cost)*(1.0 + cost));
388 
389  G4double phi = twopi * G4UniformRand() ;
390 
391  deltaDirection.set(sint*cos(phi),sint*sin(phi), cost) ;
392  deltaDirection.rotateUz(dp->GetMomentumDirection());
393  }
394 
395  // create G4DynamicParticle object for delta ray
396  G4DynamicParticle* delta =
397  new G4DynamicParticle(theElectron,deltaDirection,deltaKinEnergy);
398  vdp->push_back(delta);
399 
400  // primary change
401  kineticEnergy -= deltaKinEnergy;
402  G4ThreeVector finalP = dp->GetMomentum() - delta->GetMomentum();
403  finalP = finalP.unit();
404 
407 }
408 
409 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
virtual G4double CrossSectionPerVolume(const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy, G4double maxEnergy)
void set(double x, double y, double z)
G4IonisParamMat * GetIonisation() const
Definition: G4Material.hh:224
G4ParticleChangeForLoss * GetParticleChangeForLoss()
Definition: G4VEmModel.cc:107
virtual void SampleSecondaries(std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy)
G4bool isElectron(G4int ityp)
G4double GetKineticEnergy() const
G4double z
Definition: TRTMaterials.hh:39
const char * p
Definition: xmltok.h:285
virtual G4double ComputeCrossSectionPerAtom(const G4ParticleDefinition *, G4double kineticEnergy, G4double Z, G4double A, G4double cutEnergy, G4double maxEnergy)
void SetParticle(const G4ParticleDefinition *p)
G4VEmAngularDistribution * GetAngularDistribution()
Definition: G4VEmModel.hh:578
G4MollerBhabhaModel(const G4ParticleDefinition *p=0, const G4String &nam="MollerBhabha")
int G4int
Definition: G4Types.hh:78
virtual G4double ComputeDEDXPerVolume(const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy)
G4double GetTotalMomentum() const
string material
Definition: eplot.py:19
double precision function energy(A, Z)
Definition: dpm25nuc6.f:4106
#define G4UniformRand()
Definition: Randomize.hh:87
G4ParticleChangeForLoss * fParticleChange
virtual G4ThreeVector & SampleDirection(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, const G4Material *)=0
G4double GetElectronDensity() const
Definition: G4Material.hh:215
G4bool UseAngularGeneratorFlag() const
Definition: G4VEmModel.hh:655
const G4ParticleDefinition * particle
const G4ThreeVector & GetMomentumDirection() const
Hep3Vector & rotateUz(const Hep3Vector &)
Definition: ThreeVector.cc:72
void SetProposedKineticEnergy(G4double proposedKinEnergy)
float electron_mass_c2
Definition: hepunit.py:274
void SetProposedMomentumDirection(const G4ThreeVector &dir)
G4double G4Log(G4double x)
Definition: G4Log.hh:227
G4double GetTotNbOfAtomsPerVolume() const
Definition: G4Material.hh:207
G4ParticleDefinition * theElectron
virtual G4double MaxSecondaryEnergy(const G4ParticleDefinition *, G4double kinEnergy)
G4double DensityCorrection(G4double x)
virtual void Initialise(const G4ParticleDefinition *, const G4DataVector &)
virtual G4double ComputeCrossSectionPerElectron(const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy, G4double maxEnergy)
Hep3Vector unit() const
void SetAngularDistribution(G4VEmAngularDistribution *)
Definition: G4VEmModel.hh:585
T min(const T t1, const T t2)
brief Return the smallest of the two arguments
G4double GetMeanExcitationEnergy() const
static G4Electron * Electron()
Definition: G4Electron.cc:94
double G4double
Definition: G4Types.hh:76
G4ThreeVector GetMomentum() const
const G4Material * GetMaterial() const
G4int SelectRandomAtomNumber(const G4Material *)
Definition: G4VEmModel.hh:529