72 fProbabilities.resize(9,0.0);
75 fAtomDeexcitation = 0;
102 if ( Z < 0.9999 || GammaEnergy < 0.1*keV) {
return xSection; }
104 static const G4double a = 20.0 , b = 230.0 , c = 440.0;
107 d1= 2.7965e-1*barn, d2=-1.8300e-1*barn, d3= 6.7527 *barn, d4=-1.9798e+1*barn,
108 e1= 1.9756e-5*barn, e2=-1.0205e-2*barn, e3=-7.3913e-2*barn, e4= 2.7079e-2*barn,
109 f1=-3.9178e-7*barn, f2= 6.8241e-5*barn, f3= 6.0480e-5*barn, f4= 3.0274e-4*barn;
111 G4double p1Z = Z*(d1 + e1*Z + f1*Z*Z), p2Z = Z*(d2 + e2*Z + f2*Z*Z),
112 p3Z = Z*(d3 + e3*Z + f3*Z*Z), p4Z = Z*(d4 + e4*Z + f4*Z*Z);
115 if (Z < 1.5) { T0 = 40.0*keV; }
117 G4double X = max(GammaEnergy, T0) / electron_mass_c2;
118 xSection = p1Z*std::log(1.+2.*X)/X
119 + (p2Z + p3Z*X + p4Z*X*X)/(1. + a*X + b*X*X + c*X*X*X);
122 if (GammaEnergy < T0) {
124 X = (T0+dT0) / electron_mass_c2 ;
126 + (p2Z + p3Z*X + p4Z*X*X)/(1. + a*X + b*X*X + c*X*X*X);
127 G4double c1 = -T0*(sigma-xSection)/(xSection*dT0);
129 if (Z > 1.5) { c2 = 0.375-0.0556*log(Z); }
131 xSection *= exp(-y*(c1+c2*y));
134 if(xSection < 0.0) { xSection = 0.0; }
143 std::vector<G4DynamicParticle*>* fvect,
158 if(nShells > (
G4int)fProbabilities.size()) { fProbabilities.resize(nShells); }
161 for(i=0; i<nShells; ++i) {
165 fProbabilities[i] = totprob;
173 G4double bindingEnergy, ePotEnergy, eKinEnergy;
183 for(i=0; i<nShells; ++i) {
if(xprob <= fProbabilities[i]) {
break; } }
188 lv1.
set(0.0,0.0,energy,energy);
197 eKinEnergy = bindingEnergy*x;
198 ePotEnergy = bindingEnergy*(1.0 + x);
201 G4double eTotMomentum = sqrt(eKinEnergy*(eKinEnergy + 2*electron_mass_c2));
204 G4double sintet = sqrt((1 - costet)*(1 + costet));
205 lv2.
set(eTotMomentum*sintet*cos(phi),eTotMomentum*sintet*sin(phi),
206 eTotMomentum*costet,eKinEnergy + electron_mass_c2);
210 gamEnergy0 = lv1.
e();
216 G4double E0_m = gamEnergy0/electron_mass_c2;
222 G4double epsilon, epsilonsq, onecost, sint2, greject ;
227 G4double alpha2 = 0.5*(1 - epsilon0sq);
232 epsilonsq = epsilon*epsilon;
236 epsilon = sqrt(epsilonsq);
239 onecost = (1.- epsilon)/(epsilon*E0_m);
240 sint2 = onecost*(2.-onecost);
241 greject = 1. - epsilon*sint2/(1.+ epsilonsq);
244 gamEnergy1 = epsilon*gamEnergy0;
247 lv2.
set(0.0,0.0,0.0,electron_mass_c2);
253 if(sint2 < 0.0) { sint2 = 0.0; }
254 costet = 1. - onecost;
255 sintet = sqrt(sint2);
264 lv1.
set(gamEnergy1*v.
x(),gamEnergy1*v.
y(),gamEnergy1*v.
z(),gamEnergy1);
268 eKinEnergy = lv2.
e() - electron_mass_c2 - ePotEnergy;
271 }
while ( eKinEnergy < 0.0 );
278 gamEnergy1 = lv1.
e();
298 fvect->push_back(dp);
299 }
else { eKinEnergy = 0.0; }
301 G4double edep = energy - gamEnergy1 - eKinEnergy;
305 if(fAtomDeexcitation) {
311 size_t nbefore = fvect->size();
313 size_t nafter = fvect->size();
314 if(nafter > nbefore) {
315 for (
size_t j=nbefore; j<nafter; ++j) {
316 edep -= ((*fvect)[j])->GetKineticEnergy();
322 if(edep < 0.0) { edep = 0.0; }
CLHEP::Hep3Vector G4ThreeVector
Hep3Vector & rotateUz(const Hep3Vector &)
Hep3Vector boostVector() const
HepLorentzVector & boost(double, double, double)
void set(double x, double y, double z, double t)
const G4ThreeVector & GetMomentumDirection() const
G4double GetKineticEnergy() const
static G4Electron * Electron()
G4int GetNbOfAtomicShells() const
G4int GetNbOfShellElectrons(G4int index) const
G4double GetAtomicShell(G4int index) const
G4ParticleDefinition * theElectron
virtual void Initialise(const G4ParticleDefinition *, const G4DataVector &)
virtual ~G4KleinNishinaModel()
virtual void SampleSecondaries(std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy)
virtual G4double ComputeCrossSectionPerAtom(const G4ParticleDefinition *, G4double kinEnergy, G4double Z, G4double A, G4double cut, G4double emax)
G4KleinNishinaModel(const G4String &nam="KleinNishina")
G4ParticleChangeForGamma * fParticleChange
G4double lowestGammaEnergy
G4ParticleDefinition * theGamma
static G4LossTableManager * Instance()
G4VAtomDeexcitation * AtomDeexcitation()
void SetProposedKineticEnergy(G4double proposedKinEnergy)
void ProposeMomentumDirection(G4double Px, G4double Py, G4double Pz)
G4bool CheckDeexcitationActiveRegion(G4int coupleIndex)
virtual const G4AtomicShell * GetAtomicShell(G4int Z, G4AtomicShellEnumerator shell)=0
void GenerateParticles(std::vector< G4DynamicParticle * > *secVect, const G4AtomicShell *, G4int Z, G4int coupleIndex)
G4ParticleChangeForGamma * GetParticleChangeForGamma()
const G4Element * SelectRandomAtom(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
void SetDeexcitationFlag(G4bool val)
void InitialiseElementSelectors(const G4ParticleDefinition *, const G4DataVector &)
void ProposeTrackStatus(G4TrackStatus status)
void ProposeLocalEnergyDeposit(G4double anEnergyPart)