Geant4 11.3.0
Toolkit for the simulation of the passage of particles through matter
Loading...
Searching...
No Matches
G4EmCorrections Class Reference

#include <G4EmCorrections.hh>

Public Member Functions

 G4EmCorrections (G4int verb)
 
 ~G4EmCorrections ()
 
G4double HighOrderCorrections (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy, const G4double cutEnergy)
 
G4double IonHighOrderCorrections (const G4ParticleDefinition *, const G4MaterialCutsCouple *, const G4double kineticEnergy)
 
G4double ComputeIonCorrections (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double IonBarkasCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double Bethe (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double SpinCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double KShellCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double LShellCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double ShellCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double ShellCorrectionSTD (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double DensityCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double BarkasCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy, const G4bool isInitialized=false)
 
G4double BlochCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy, const G4bool isInitialized=false)
 
G4double MottCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy, const G4bool isInitialized=false)
 
void AddStoppingData (const G4int Z, const G4int A, const G4String &materialName, G4PhysicsVector *dVector)
 
void InitialiseForNewRun ()
 
G4double EffectiveChargeCorrection (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double GetParticleCharge (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
G4double EffectiveChargeSquareRatio (const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
 
void SetIonisationModels (G4VEmModel *mod1=nullptr, G4VEmModel *mod2=nullptr)
 
G4int GetNumberOfStoppingVectors () const
 
void SetVerbose (G4int verb)
 
G4EmCorrectionsoperator= (const G4EmCorrections &right)=delete
 
 G4EmCorrections (const G4EmCorrections &)=delete
 

Detailed Description

Definition at line 68 of file G4EmCorrections.hh.

Constructor & Destructor Documentation

◆ G4EmCorrections() [1/2]

G4EmCorrections::G4EmCorrections ( G4int verb)
explicit

Definition at line 111 of file G4EmCorrections.cc.

112 : verbose(verb)
113{
114 eth = 2.0*CLHEP::MeV;
115 eCorrMin = 25.*CLHEP::keV;
116 eCorrMax = 1.*CLHEP::GeV;
117
119 g4calc = G4Pow::GetInstance();
120
121 // fill vectors
122 if (nullptr == sBarkasCorr) {
123 Initialise();
124 isInitializer = true;
125 }
126}
G4IonTable * GetIonTable() const
static G4ParticleTable * GetParticleTable()
static G4Pow * GetInstance()
Definition G4Pow.cc:41

Referenced by G4EmCorrections(), and operator=().

◆ ~G4EmCorrections()

G4EmCorrections::~G4EmCorrections ( )

Definition at line 130 of file G4EmCorrections.cc.

131{
132 for (G4int i=0; i<nIons; ++i) { delete stopData[i]; }
133 if (isInitializer) {
134 delete sBarkasCorr;
135 delete sThetaK;
136 delete sThetaL;
137 sBarkasCorr = sThetaK = sThetaL = nullptr;
138 }
139}
int G4int
Definition G4Types.hh:85

◆ G4EmCorrections() [2/2]

G4EmCorrections::G4EmCorrections ( const G4EmCorrections & )
delete

Member Function Documentation

◆ AddStoppingData()

void G4EmCorrections::AddStoppingData ( const G4int Z,
const G4int A,
const G4String & materialName,
G4PhysicsVector * dVector )

Definition at line 775 of file G4EmCorrections.cc.

778{
779 G4int i = 0;
780 for(; i<nIons; ++i) {
781 if(Z == Zion[i] && A == Aion[i] && mname == materialName[i]) break;
782 }
783 if(i == nIons) {
784 Zion.push_back(Z);
785 Aion.push_back(A);
786 materialName.push_back(mname);
787 materialList.push_back(nullptr);
788 ionList.push_back(nullptr);
789 stopData.push_back(dVector);
790 nIons++;
791 if(verbose > 1) {
792 G4cout << "AddStoppingData Z= " << Z << " A= " << A << " " << mname
793 << " idx= " << i << G4endl;
794 }
795 }
796}
const G4double A[17]
#define G4endl
Definition G4ios.hh:67
G4GLOB_DLL std::ostream G4cout

◆ BarkasCorrection()

G4double G4EmCorrections::BarkasCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy,
const G4bool isInitialized = false )

Definition at line 638 of file G4EmCorrections.cc.

642{
643 // . Z^3 Barkas effect in the stopping power of matter for charged particles
644 // J.C Ashley and R.H.Ritchie
645 // Physical review B Vol.5 No.7 1 April 1972 pp. 2393-2397
646 // valid for kineticEnergy > 0.5 MeV
647
648 if (!isInitialized) { SetupKinematics(p, mat, e); }
649 G4double BarkasTerm = 0.0;
650
651 for (G4int i = 0; i<numberOfElements; ++i) {
652
653 const G4int iz = (*theElementVector)[i]->GetZasInt();
654 if(iz == 47) {
655 BarkasTerm += atomDensity[i]*0.006812*G4Exp(-G4Log(beta)*0.9);
656 } else if(iz >= 64) {
657 BarkasTerm += atomDensity[i]*0.002833*G4Exp(-G4Log(beta)*1.2);
658 } else {
659
660 const G4double Z = (*theElementVector)[i]->GetZ();
661 const G4double X = ba2 / Z;
662 G4double b = 1.3;
663 if(1 == iz) { b = (material->GetName() == "G4_lH2") ? 0.6 : 1.8; }
664 else if(2 == iz) { b = 0.6; }
665 else if(10 >= iz) { b = 1.8; }
666 else if(17 >= iz) { b = 1.4; }
667 else if(18 == iz) { b = 1.8; }
668 else if(25 >= iz) { b = 1.4; }
669 else if(50 >= iz) { b = 1.35;}
670
671 const G4double W = b/std::sqrt(X);
672
673 G4double val = sBarkasCorr->Value(W, idxBarkas);
674 if (W > sWmaxBarkas) { val *= (sWmaxBarkas/W); }
675 // G4cout << "i= " << i << " b= " << b << " W= " << W
676 // << " Z= " << Z << " X= " << X << " val= " << val<< G4endl;
677 BarkasTerm += val*atomDensity[i] / (std::sqrt(Z*X)*X);
678 }
679 }
680
681 BarkasTerm *= 1.29*charge/material->GetTotNbOfAtomsPerVolume();
682
683 return BarkasTerm;
684}
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition G4Exp.hh:180
G4double G4Log(G4double x)
Definition G4Log.hh:227
double G4double
Definition G4Types.hh:83
#define W
Definition crc32.c:85

Referenced by ComputeIonCorrections(), HighOrderCorrections(), and IonBarkasCorrection().

◆ Bethe()

G4double G4EmCorrections::Bethe ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 292 of file G4EmCorrections.cc.

295{
296 SetupKinematics(p, mat, e);
297 const G4double eexc = material->GetIonisation()->GetMeanExcitationEnergy();
298 const G4double eexc2 = eexc*eexc;
299 return 0.5*G4Log(2.0*electron_mass_c2*bg2*tmax/eexc2)-beta2;
300}

◆ BlochCorrection()

G4double G4EmCorrections::BlochCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy,
const G4bool isInitialized = false )

Definition at line 688 of file G4EmCorrections.cc.

692{
693 if (!isInitialized) { SetupKinematics(p, mat, e); }
694
695 G4double y2 = q2/ba2;
696
697 G4double term = 1.0/(1.0 + y2);
698 G4double del;
699 G4double j = 1.0;
700 do {
701 j += 1.0;
702 del = 1.0/(j* (j*j + y2));
703 term += del;
704 // Loop checking, 03-Aug-2015, Vladimir Ivanchenko
705 } while (del > 0.01*term);
706
707 return -y2*term;
708}

Referenced by ComputeIonCorrections(), and HighOrderCorrections().

◆ ComputeIonCorrections()

G4double G4EmCorrections::ComputeIonCorrections ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 218 of file G4EmCorrections.cc.

221{
222 // . Z^3 Barkas effect in the stopping power of matter for charged particles
223 // J.C Ashley and R.H.Ritchie
224 // Physical review B Vol.5 No.7 1 April 1972 pagg. 2393-2397
225 // and ICRU49 report
226 // valid for kineticEnergy < 0.5 MeV
227 // Other corrections from S.P.Ahlen Rev. Mod. Phys., Vol 52, No1, 1980
228 SetupKinematics(p, mat, e);
229 if(tau <= 0.0) { return 0.0; }
230
231 const G4double Barkas = BarkasCorrection (p, mat, e, true);
232 const G4double Bloch = BlochCorrection (p, mat, e, true);
233 const G4double Mott = MottCorrection (p, mat, e, true);
234
235 G4double sum = 2.0*(Barkas*(charge - 1.0)/charge + Bloch) + Mott;
236
237 if(verbose > 1) {
238 G4cout << "EmCorrections: E(MeV)= " << e/MeV << " Barkas= " << Barkas
239 << " Bloch= " << Bloch << " Mott= " << Mott
240 << " Sum= " << sum << G4endl;
241 }
242 sum *= material->GetElectronDensity() * q2 * CLHEP::twopi_mc2_rcl2 /beta2;
243
244 if(verbose > 1) { G4cout << " Sum= " << sum << G4endl; }
245 return sum;
246}
G4double MottCorrection(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy, const G4bool isInitialized=false)
G4double BlochCorrection(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy, const G4bool isInitialized=false)
G4double BarkasCorrection(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy, const G4bool isInitialized=false)

Referenced by IonHighOrderCorrections().

◆ DensityCorrection()

G4double G4EmCorrections::DensityCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 611 of file G4EmCorrections.cc.

614{
615 SetupKinematics(p, mat, e);
616
617 G4double cden = material->GetIonisation()->GetCdensity();
618 G4double mden = material->GetIonisation()->GetMdensity();
619 G4double aden = material->GetIonisation()->GetAdensity();
620 G4double x0den = material->GetIonisation()->GetX0density();
621 G4double x1den = material->GetIonisation()->GetX1density();
622
623 G4double dedx = 0.0;
624
625 // density correction
626 static const G4double twoln10 = 2.0*G4Log(10.0);
627 G4double x = G4Log(bg2)/twoln10;
628 if ( x >= x0den ) {
629 dedx = twoln10*x - cden ;
630 if ( x < x1den ) dedx += aden*G4Exp(G4Log(x1den-x)*mden) ;
631 }
632
633 return dedx;
634}

◆ EffectiveChargeCorrection()

G4double G4EmCorrections::EffectiveChargeCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 724 of file G4EmCorrections.cc.

727{
728 G4double factor = 1.0;
729 if(p->GetPDGCharge() <= 2.5*CLHEP::eplus || nIons <= 0) { return factor; }
730
731 if(verbose > 1) {
732 G4cout << "EffectiveChargeCorrection: " << p->GetParticleName()
733 << " in " << mat->GetName()
734 << " ekin(MeV)= " << ekin/MeV << G4endl;
735 }
736
737 if(p != curParticle || mat != curMaterial) {
738 curParticle = p;
739 curMaterial = mat;
740 curVector = nullptr;
741 currentZ = p->GetAtomicNumber();
742 if(verbose > 1) {
743 G4cout << "G4EmCorrections::EffectiveChargeCorrection: Zion= "
744 << currentZ << " Aion= " << p->GetPDGMass()/amu_c2 << G4endl;
745 }
746 massFactor = CLHEP::proton_mass_c2/p->GetPDGMass();
747 idx = -1;
748
749 for(G4int i=0; i<nIons; ++i) {
750 if(materialList[i] == mat && currentZ == Zion[i]) {
751 idx = i;
752 break;
753 }
754 }
755 //G4cout << " idx= " << idx << " dz= " << G4endl;
756 if(idx >= 0) {
757 if(nullptr == ionList[idx]) { BuildCorrectionVector(); }
758 curVector = stopData[idx];
759 } else {
760 return factor;
761 }
762 }
763 if(nullptr != curVector) {
764 factor = curVector->Value(ekin*massFactor);
765 if(verbose > 1) {
766 G4cout << "E= " << ekin << " factor= " << factor << " massfactor= "
767 << massFactor << G4endl;
768 }
769 }
770 return factor;
771}
const G4String & GetName() const
G4int GetAtomicNumber() const
const G4String & GetParticleName() const

◆ EffectiveChargeSquareRatio()

G4double G4EmCorrections::EffectiveChargeSquareRatio ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )
inline

Definition at line 320 of file G4EmCorrections.hh.

323{
324 return effCharge.EffectiveChargeSquareRatio(p,mat,kineticEnergy);
325}

◆ GetNumberOfStoppingVectors()

G4int G4EmCorrections::GetNumberOfStoppingVectors ( ) const
inline

Definition at line 306 of file G4EmCorrections.hh.

307{
308 return nIons;
309}

◆ GetParticleCharge()

G4double G4EmCorrections::GetParticleCharge ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )
inline

Definition at line 312 of file G4EmCorrections.hh.

315{
316 return effCharge.EffectiveCharge(p,mat,kineticEnergy);
317}

◆ HighOrderCorrections()

G4double G4EmCorrections::HighOrderCorrections ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy,
const G4double cutEnergy )

Definition at line 172 of file G4EmCorrections.cc.

175{
176 // . Z^3 Barkas effect in the stopping power of matter for charged particles
177 // J.C Ashley and R.H.Ritchie
178 // Physical review B Vol.5 No.7 1 April 1972 pagg. 2393-2397
179 // and ICRU49 report
180 // valid for kineticEnergy < 0.5 MeV
181 // Other corrections from S.P.Ahlen Rev. Mod. Phys., Vol 52, No1, 1980
182
183 SetupKinematics(p, mat, e);
184 if(tau <= 0.0) { return 0.0; }
185
186 const G4double Barkas = BarkasCorrection(p, mat, e, true);
187 const G4double Bloch = BlochCorrection(p, mat, e, true);
188 const G4double Mott = MottCorrection(p, mat, e, true);
189
190 G4double sum = 2.0*(Barkas + Bloch) + Mott;
191
192 if(verbose > 1) {
193 G4cout << "EmCorrections: E(MeV)= " << e/MeV << " Barkas= " << Barkas
194 << " Bloch= " << Bloch << " Mott= " << Mott
195 << " Sum= " << sum << " q2= " << q2 << G4endl;
196 G4cout << " ShellCorrection: " << ShellCorrection(p, mat, e)
197 << " Kshell= " << KShellCorrection(p, mat, e)
198 << " Lshell= " << LShellCorrection(p, mat, e)
199 << " " << mat->GetName() << G4endl;
200 }
201 sum *= material->GetElectronDensity()*q2*CLHEP::twopi_mc2_rcl2/beta2;
202 return sum;
203}
G4double KShellCorrection(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
G4double LShellCorrection(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
G4double ShellCorrection(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)

◆ InitialiseForNewRun()

void G4EmCorrections::InitialiseForNewRun ( )

Definition at line 867 of file G4EmCorrections.cc.

868{
869 G4ProductionCutsTable* tb = G4ProductionCutsTable::GetProductionCutsTable();
870 ncouples = tb->GetTableSize();
871 if(currmat.size() != ncouples) {
872 currmat.resize(ncouples);
873 for(auto it = thcorr.begin(); it != thcorr.end(); ++it){
874 (it->second).clear();
875 }
876 thcorr.clear();
877 for(std::size_t i=0; i<ncouples; ++i) {
878 currmat[i] = tb->GetMaterialCutsCouple((G4int)i)->GetMaterial();
879 G4String nam = currmat[i]->GetName();
880 for(G4int j=0; j<nIons; ++j) {
881 if(nam == materialName[j]) { materialList[j] = currmat[i]; }
882 }
883 }
884 }
885}
const G4Material * GetMaterial() const
const G4MaterialCutsCouple * GetMaterialCutsCouple(G4int i) const
std::size_t GetTableSize() const
static G4ProductionCutsTable * GetProductionCutsTable()

◆ IonBarkasCorrection()

G4double G4EmCorrections::IonBarkasCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 207 of file G4EmCorrections.cc.

210{
211 SetupKinematics(p, mat, e);
212 return 2.0*BarkasCorrection(p, mat, e, true)*
213 material->GetElectronDensity() * q2 * CLHEP::twopi_mc2_rcl2 /beta2;
214}

◆ IonHighOrderCorrections()

G4double G4EmCorrections::IonHighOrderCorrections ( const G4ParticleDefinition * p,
const G4MaterialCutsCouple * couple,
const G4double kineticEnergy )

Definition at line 250 of file G4EmCorrections.cc.

253{
254 // . Z^3 Barkas effect in the stopping power of matter for charged particles
255 // J.C Ashley and R.H.Ritchie
256 // Physical review B Vol.5 No.7 1 April 1972 pagg. 2393-2397
257 // and ICRU49 report
258 // valid for kineticEnergy < 0.5 MeV
259 // Other corrections from S.P.Ahlen Rev. Mod. Phys., Vol 52, No1, 1980
260
261 G4double sum = 0.0;
262
263 if (nullptr != ionHEModel) {
264 G4int Z = G4lrint(p->GetPDGCharge()*inveplus);
265 Z = std::max(std::min(Z, 99), 1);
266
267 const G4double ethscaled = eth*p->GetPDGMass()/CLHEP::proton_mass_c2;
268 const G4int ionPDG = p->GetPDGEncoding();
269 auto iter = thcorr.find(ionPDG);
270 if (iter == thcorr.end()) { // Not found: fill the map
271 std::vector<G4double> v;
272 for(std::size_t i=0; i<ncouples; ++i){
273 v.push_back(ethscaled*ComputeIonCorrections(p,currmat[i],ethscaled));
274 }
275 thcorr.insert(std::pair< G4int, std::vector<G4double> >(ionPDG,v));
276 }
277 G4double rest = 0.0;
278 iter = thcorr.find(ionPDG);
279 if (iter != thcorr.end()) { rest = (iter->second)[couple->GetIndex()]; }
280
281 sum = ComputeIonCorrections(p,couple->GetMaterial(),e) - rest/e;
282
283 if(verbose > 1) {
284 G4cout << " Sum= " << sum << " dSum= " << rest/e << G4endl;
285 }
286 }
287 return sum;
288}
G4double ComputeIonCorrections(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)
int G4lrint(double ad)
Definition templates.hh:134

◆ KShellCorrection()

G4double G4EmCorrections::KShellCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 315 of file G4EmCorrections.cc.

318{
319 SetupKinematics(p, mat, e);
320 G4double term = 0.0;
321 for (G4int i = 0; i<numberOfElements; ++i) {
322
323 G4double Z = (*theElementVector)[i]->GetZ();
324 G4int iz = (*theElementVector)[i]->GetZasInt();
325 G4double f = 1.0;
326 G4double Z2= (Z-0.3)*(Z-0.3);
327 if(1 == iz) {
328 f = 0.5;
329 Z2 = 1.0;
330 }
331 const G4double eta = ba2/Z2;
332 const G4double tet = (11 < iz) ? sThetaK->Value(Z) : Z2*(1. + Z2*0.25*alpha2);
333 term += f*atomDensity[i]*KShell(tet,eta)/Z;
334 }
335
336 term /= material->GetTotNbOfAtomsPerVolume();
337
338 return term;
339}
const G4double alpha2

Referenced by HighOrderCorrections().

◆ LShellCorrection()

G4double G4EmCorrections::LShellCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 343 of file G4EmCorrections.cc.

346{
347 SetupKinematics(p, mat, e);
348 G4double term = 0.0;
349 for (G4int i = 0; i<numberOfElements; ++i) {
350
351 const G4double Z = (*theElementVector)[i]->GetZ();
352 const G4int iz = (*theElementVector)[i]->GetZasInt();
353 if(2 < iz) {
354 const G4double Zeff = (iz < 10) ? Z - ZD[iz] : Z - ZD[10];
355 const G4double Z2= Zeff*Zeff;
356 const G4double eta = ba2/Z2;
357 G4double tet = sThetaL->Value(Z);
358 G4int nmax = std::min(4, G4AtomicShells::GetNumberOfShells(iz));
359 for (G4int j=1; j<nmax; ++j) {
361 if (15 >= iz) {
362 tet = (3 > j) ? 0.25*Z2*(1.0 + 5*Z2*alpha2/16.) :
363 0.25*Z2*(1.0 + Z2*alpha2/16.);
364 }
365 //G4cout << " LShell: j= " << j << " ne= " << ne << " e(eV)= " << e/eV
366 // << " ThetaL= " << tet << G4endl;
367 term += 0.125*ne*atomDensity[i]*LShell(tet,eta)/Z;
368 }
369 }
370 }
371
372 term /= material->GetTotNbOfAtomsPerVolume();
373
374 return term;
375}
static G4int GetNumberOfElectrons(G4int Z, G4int SubshellNb)
static G4int GetNumberOfShells(G4int Z)

Referenced by HighOrderCorrections().

◆ MottCorrection()

G4double G4EmCorrections::MottCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy,
const G4bool isInitialized = false )

Definition at line 712 of file G4EmCorrections.cc.

716{
717 if (!isInitialized) { SetupKinematics(p, mat, e); }
718 return CLHEP::pi*CLHEP::fine_structure_const*beta*charge;
719}

Referenced by ComputeIonCorrections(), and HighOrderCorrections().

◆ operator=()

G4EmCorrections & G4EmCorrections::operator= ( const G4EmCorrections & right)
delete

◆ SetIonisationModels()

void G4EmCorrections::SetIonisationModels ( G4VEmModel * mod1 = nullptr,
G4VEmModel * mod2 = nullptr )
inline

Definition at line 300 of file G4EmCorrections.hh.

301{
302 if(nullptr != mod1) { ionLEModel = mod1; }
303 if(nullptr != mod2) { ionHEModel = mod2; }
304}

◆ SetVerbose()

void G4EmCorrections::SetVerbose ( G4int verb)
inline

Definition at line 327 of file G4EmCorrections.hh.

328{
329 verbose = verb;
330}

◆ ShellCorrection()

G4double G4EmCorrections::ShellCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 509 of file G4EmCorrections.cc.

512{
513 SetupKinematics(p, mat, ekin);
514 G4double term = 0.0;
515 //G4cout << "### G4EmCorrections::ShellCorrection " << mat->GetName()
516 // << " " << ekin/MeV << " MeV " << G4endl;
517 for (G4int i = 0; i<numberOfElements; ++i) {
518
519 G4double res = 0.0;
520 G4double res0 = 0.0;
521 const G4double Z = (*theElementVector)[i]->GetZ();
522 const G4int iz = (*theElementVector)[i]->GetZasInt();
523 G4double Z2= (Z-0.3)*(Z-0.3);
524 G4double f = 1.0;
525 if(1 == iz) {
526 f = 0.5;
527 Z2 = 1.0;
528 }
529 G4double eta = ba2/Z2;
530 G4double tet = (11 < iz) ? sThetaK->Value(Z) : Z2*(1. + Z2*0.25*alpha2);
531 res0 = f*KShell(tet,eta);
532 res += res0;
533 //G4cout << " Z= " << iz << " Shell 0" << " tet= " << tet
534 // << " eta= " << eta << " resK= " << res0 << G4endl;
535
536 if(2 < iz) {
537 const G4double Zeff = (iz < 10) ? Z - ZD[iz] : Z - ZD[10];
538 Z2= Zeff*Zeff;
539 eta = ba2/Z2;
540 tet = sThetaL->Value(Z);
541 f = 0.125;
543 const G4int nmax = std::min(4, ntot);
544 G4double norm = 0.0;
545 G4double eshell = 0.0;
546 for(G4int j=1; j<nmax; ++j) {
548 if(15 >= iz) {
549 tet = (3 > j) ? 0.25*Z2*(1.0 + 5*Z2*alpha2/16.) :
550 0.25*Z2*(1.0 + Z2*alpha2/16.);
551 }
552 norm += ne;
553 eshell += tet*ne;
554 res0 = f*ne*LShell(tet,eta);
555 res += res0;
556 //G4cout << " Zeff= " << Zeff << " Shell " << j << " Ne= " << ne
557 // << " tet= " << tet << " eta= " << eta
558 // << " resL= " << res0 << G4endl;
559 }
560 if(ntot > nmax) {
561 if (norm > 0.0) { norm = 1.0/norm; }
562 eshell *= norm;
563
564 static const G4double HM[53] = {
565 12.0, 12.0, 12.0, 12.0, 11.9, 11.7, 11.5, 11.2, 10.8, 10.4,
566 10.0, 9.51, 8.97, 8.52, 8.03, 7.46, 6.95, 6.53, 6.18, 5.87,
567 5.61, 5.39, 5.19, 5.01, 4.86, 4.72, 4.62, 4.53, 4.44, 4.38,
568 4.32, 4.26, 4.20, 4.15, 4.1, 4.04, 4.00, 3.95, 3.93, 3.91,
569 3.90, 3.89, 3.89, 3.88, 3.88, 3.88, 3.88, 3.88, 3.89, 3.89,
570 3.90, 3.92, 3.93 };
571 static const G4double HN[31] = {
572 75.5, 61.9, 52.2, 45.1, 39.6, 35.4, 31.9, 29.1, 27.2, 25.8,
573 24.5, 23.6, 22.7, 22.0, 21.4, 20.9, 20.5, 20.2, 19.9, 19.7,
574 19.5, 19.3, 19.2, 19.1, 18.4, 18.8, 18.7, 18.6, 18.5, 18.4,
575 18.2};
576
577 // Add M-shell
578 if(28 > iz) {
579 res += f*(iz - 10)*LShell(eshell,HM[iz-11]*eta);
580 } else if(63 > iz) {
581 res += f*18*LShell(eshell,HM[iz-11]*eta);
582 } else {
583 res += f*18*LShell(eshell,HM[52]*eta);
584 }
585 // Add N-shell
586 if(32 < iz) {
587 if(60 > iz) {
588 res += f*(iz - 28)*LShell(eshell,HN[iz-33]*eta);
589 } else if(63 > iz) {
590 res += 4*LShell(eshell,HN[iz-33]*eta);
591 } else {
592 res += 4*LShell(eshell,HN[30]*eta);
593 }
594 // Add O-P-shells
595 if(60 < iz) {
596 res += f*(iz - 60)*LShell(eshell,150*eta);
597 }
598 }
599 }
600 }
601 term += res*atomDensity[i]/Z;
602 }
603
604 term /= material->GetTotNbOfAtomsPerVolume();
605 //G4cout << "##Shell Correction=" << term << G4endl;
606 return term;
607}

Referenced by HighOrderCorrections().

◆ ShellCorrectionSTD()

G4double G4EmCorrections::ShellCorrectionSTD ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 475 of file G4EmCorrections.cc.

478{
479 SetupKinematics(p, mat, e);
480 G4double taulim= 8.0*MeV/mass;
481 G4double bg2lim= taulim * (taulim+2.0);
482
483 G4double* shellCorrectionVector =
484 material->GetIonisation()->GetShellCorrectionVector();
485 G4double sh = 0.0;
486 G4double x = 1.0;
487 G4double taul = material->GetIonisation()->GetTaul();
488
489 if ( bg2 >= bg2lim ) {
490 for (G4int k=0; k<3; ++k) {
491 x *= bg2 ;
492 sh += shellCorrectionVector[k]/x;
493 }
494
495 } else {
496 for (G4int k=0; k<3; ++k) {
497 x *= bg2lim ;
498 sh += shellCorrectionVector[k]/x;
499 }
500 sh *= G4Log(tau/taul)/G4Log(taulim/taul);
501 }
502 sh *= 0.5;
503 return sh;
504}

◆ SpinCorrection()

G4double G4EmCorrections::SpinCorrection ( const G4ParticleDefinition * p,
const G4Material * mat,
const G4double kineticEnergy )

Definition at line 304 of file G4EmCorrections.cc.

307{
308 SetupKinematics(p, mat, e);
309 const G4double dedx = 0.5*tmax/(kinEnergy + mass);
310 return 0.5*dedx*dedx;
311}

The documentation for this class was generated from the following files: