85 G4cout <<
"Rudd ionisation model is constructed " <<
G4endl;
107 std::map< G4String,G4DNACrossSectionDataSet*,std::less<G4String> >::iterator
pos;
126 G4cout <<
"Calling G4DNARuddIonisationExtendedModel::Initialise()" <<
G4endl;
130 G4String fileProton(
"dna/sigma_ionisation_p_rudd");
131 G4String fileHydrogen(
"dna/sigma_ionisation_h_rudd");
132 G4String fileAlphaPlusPlus(
"dna/sigma_ionisation_alphaplusplus_rudd");
133 G4String fileAlphaPlus(
"dna/sigma_ionisation_alphaplus_rudd");
134 G4String fileHelium(
"dna/sigma_ionisation_he_rudd");
135 G4String fileLithium(
"dna/sigma_ionisation_li_rudd");
136 G4String fileBeryllium(
"dna/sigma_ionisation_be_rudd");
137 G4String fileBoron(
"dna/sigma_ionisation_b_rudd");
138 G4String fileCarbon(
"dna/sigma_ionisation_c_rudd");
139 G4String fileNitrogen(
"dna/sigma_ionisation_n_rudd");
140 G4String fileOxygen(
"dna/sigma_ionisation_o_rudd");
141 G4String fileSilicon(
"dna/sigma_ionisation_si_rudd");
142 G4String fileIron(
"dna/sigma_ionisation_fe_rudd");
213 tableHydrogen->
LoadData(fileHydrogen);
220 tableFile[alphaPlusPlus] = fileAlphaPlusPlus;
230 tableAlphaPlusPlus->
LoadData(fileAlphaPlusPlus);
232 tableData[alphaPlusPlus] = tableAlphaPlusPlus;
247 tableAlphaPlus->
LoadData(fileAlphaPlus);
283 tableLithium->
LoadData(fileLithium);
303 tableBeryllium->
LoadData(fileBeryllium);
383 tableNitrogen->
LoadData(fileNitrogen);
402 tableSilicon->
LoadData(fileSilicon);
433 if (particle==protonDef)
439 if (particle==hydrogenDef)
445 if (particle==heliumDef)
451 if (particle==alphaPlusDef)
457 if (particle==alphaPlusPlusDef)
463 if (particle==lithiumDef)
469 if (particle==berylliumDef)
475 if (particle==boronDef)
481 if (particle==carbonDef)
487 if (particle==nitrogenDef)
493 if (particle==oxygenDef)
499 if (particle==siliconDef)
505 if (particle==ironDef)
515 G4cout <<
"Rudd ionisation model is initialized " << G4endl
548 G4cout <<
"Calling CrossSectionPerVolume() of G4DNARuddIonisationExtendedModel" <<
G4endl;
558 particleDefinition != instance->
GetIon(
"hydrogen")
560 particleDefinition != instance->
GetIon(
"alpha++")
562 particleDefinition != instance->
GetIon(
"alpha+")
564 particleDefinition != instance->
GetIon(
"helium")
597 || particleDefinition == instance->
GetIon(
"hydrogen")
602 else if ( particleDefinition == instance->
GetIon(
"alpha++")
603 || particleDefinition == instance->
GetIon(
"alpha+")
604 || particleDefinition == instance->
GetIon(
"helium")
617 if(waterDensity!= 0.0)
622 std::map< G4String,G4double,std::less<G4String> >::iterator pos2;
627 highLim = pos2->second;
635 if (k < lowLim) k = lowLim;
639 std::map< G4String,G4DNACrossSectionDataSet*,std::less<G4String> >::iterator
pos;
652 G4Exception(
"G4DNARuddIonisationExtendedModel::CrossSectionPerVolume",
"em0002",
660 G4cout <<
"__________________________________" <<
G4endl;
661 G4cout <<
"G4DNARuddIonisationExtendedModel - XS INFO START" <<
G4endl;
663 G4cout <<
"Cross section per water molecule (cm^2)=" << sigma/
cm/
cm <<
G4endl;
664 G4cout <<
"Cross section per water molecule (cm^-1)=" << sigma*waterDensity/(1./
cm) << G4endl;
666 G4cout <<
"G4DNARuddIonisationExtendedModel - XS INFO END" <<
G4endl;
672 return sigma*waterDensity;
691 G4cout <<
"Calling SampleSecondaries() of G4DNARuddIonisationExtendedModel" <<
G4endl;
737 std::map< G4String,G4double,std::less<G4String> >::iterator pos2;
742 if (k >= lowLim && k <= highLim)
765 if (k<bindingEnergy)
return;
778 fvect->push_back(dp);
782 G4double scatteredEnergy = k-bindingEnergy-secondaryKinetic;
816 G4int secNumberInit = 0;
817 G4int secNumberFinal = 0;
822 if (ionizationShell <5 && ionizationShell >1)
826 else if (ionizationShell <2)
842 secNumberInit = fvect->size();
844 secNumberFinal = fvect->size();
848 for (
G4int j=secNumberInit; j < secNumberFinal; j++) {
849 deexSecEnergy = deexSecEnergy + (*fvect)[j]->GetKineticEnergy();
910 value_sampling =
RejectionFunction(particleDefinition, k, proposed_energy, shell);
912 }
while(random1 > value_sampling);
914 return(proposed_energy);
965 G4int ionizationLevelIndex)
967 const G4int j=ionizationLevelIndex;
970 const G4double Gj[5] = {0.99, 1.11, 1.11, 0.52, 1.};
987 Bj_energy = Bj[ionizationLevelIndex];
990 G4double energyTransfer = proposed_ws + Bj_energy;
991 proposed_ws/=Bj_energy;
1002 if((tau/
MeV)<5.447761194
e-2)
1004 v2 = tau / Bj_energy;
1015 G4double wc = 4.*v2 - 2.*v - (Ry/(4.*Bj_energy));
1016 G4double rejection_term = 1.+
G4Exp(alphaConst*(proposed_ws - wc) / v);
1017 rejection_term = (1./rejection_term)*
CorrectionFactor(particleDefinition,k,ionizationLevelIndex) * Gj[j];
1023 || particleDefinition == instance->
GetIon(
"hydrogen")
1026 return(rejection_term);
1033 G4double x = 100.*std::sqrt(beta2)/std::pow(Z,(2./3.));
1034 G4double Zeffion = Z*(1.-
G4Exp(-1.316*x+0.112*x*x-0.0650*x*x*x));
1035 rejection_term*=Zeffion*Zeffion;
1038 else if (particleDefinition == instance->
GetIon(
"alpha++") )
1049 else if (particleDefinition == instance->
GetIon(
"alpha+") )
1062 else if (particleDefinition == instance->
GetIon(
"helium") )
1087 rejection_term*= zEff * zEff;
1090 return (rejection_term);
1099 G4int ionizationLevelIndex)
1102 const G4int j=ionizationLevelIndex;
1147 Bj_energy = Bj[ionizationLevelIndex];
1158 if((tau/
MeV)<5.447761194
e-2)
1160 v2 = tau / Bj_energy;
1172 G4double L1 = (C1* std::pow(v,(D1))) / (1.+ E1*std::pow(v, (D1+4.)));
1174 G4double H1 = (A1*std::log(1.+v2)) / (v2+(B1/v2));
1175 G4double H2 = (A2/v2) + (B2/(v2*v2));
1190 G4double gamma = 1./sqrt(1.-beta2);
1199 G4double wmax = maximumEnergy/Bj_energy;
1200 G4double c = wmax*(F2*wmax+F1*(2.+wmax))/(2.*(1.+wmax)*(1.+wmax));
1203 G4double proposed_ws = F1*F1*c*c + 2.*F2*c*randVal - 2.*F1*c*randVal;
1204 proposed_ws = -F1*c+2.*randVal+std::sqrt(proposed_ws);
1206 proposed_ws/= ( F1*c + F2*c - 2.*randVal );
1207 proposed_ws*=Bj_energy;
1209 return(proposed_ws);
1223 G4double r =
R(t, energyTransferred, slaterEffectiveChg, shellNumber);
1239 G4double r =
R(t, energyTransferred, slaterEffectiveChg, shellNumber);
1256 G4double r =
R(t, energyTransferred, slaterEffectiveChg, shellNumber);
1257 G4double value = 1. -
G4Exp(-2 * r) * (((( 2./3. * r + 4./3.) * r + 2.) * r + 2.) * r + 1.);
1272 G4double tElectron = 0.511/3728. * t;
1275 G4double value = std::sqrt ( 2. * tElectron / H ) / ( energyTransferred / H ) * (slaterEffectiveChg/shellNumber);
1288 if (particleDefinition == instance->
GetIon(
"hydrogen") && shell < 4)
1292 return((0.6/(1+
G4Exp(value))) + 0.9);
1309 std::map< G4String,G4DNACrossSectionDataSet*,std::less<G4String> >::iterator
pos;
1329 value += valuesBuffer[i];
1340 if (valuesBuffer[i] > value)
1342 delete[] valuesBuffer;
1345 value -= valuesBuffer[i];
1348 if (valuesBuffer)
delete[] valuesBuffer;
1354 G4Exception(
"G4DNARuddIonisationExtendedModel::RandomSelect",
"em0002",
1375 std::map< G4String,G4double,std::less<G4String> >::iterator pos1;
1380 lowLim = pos1->second;
1383 std::map< G4String,G4double,std::less<G4String> >::iterator pos2;
1388 highLim = pos2->second;
1391 if (k >= lowLim && k <= highLim)
1393 std::map< G4String,G4DNACrossSectionDataSet*,std::less<G4String> >::iterator
pos;
1406 G4Exception(
"G4DNARuddIonisationExtendedModel::PartialCrossSection",
"em0002",
G4double S_2p(G4double t, G4double energyTransferred, G4double slaterEffectiveChg, G4double shellNumber)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
G4DNAWaterIonisationStructure waterStructure
virtual G4bool LoadData(const G4String &argFileName)
G4int GetAtomicNumber() const
virtual G4double CrossSectionPerVolume(const G4Material *material, const G4ParticleDefinition *p, G4double ekin, G4double emin, G4double emax)
static const G4double pos
virtual const G4AtomicShell * GetAtomicShell(G4int Z, G4AtomicShellEnumerator shell)=0
G4double PartialCrossSection(const G4Track &track)
G4VAtomDeexcitation * AtomDeexcitation()
static constexpr double MeV
virtual void SampleSecondaries(std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy)
void SetHighEnergyLimit(G4double)
virtual size_t NumberOfComponents(void) const
G4VAtomDeexcitation * fAtomDeexcitation
static G4IonTable * GetIonTable()
static constexpr double keV
const G4ThreeVector & GetMomentumDirection() const
std::map< G4double, G4double > killBelowEnergyForA
G4double S_1s(G4double t, G4double energyTransferred, G4double slaterEffectiveChg, G4double shellNumber)
const G4String & GetParticleName() const
G4double GetPDGCharge() const
void SetProposedKineticEnergy(G4double proposedKinEnergy)
G4double S_2s(G4double t, G4double energyTransferred, G4double slaterEffectiveChg, G4double shellNumber)
static G4Material * GetMaterial(const G4String &name, G4bool warning=true)
G4double GetPDGMass() const
G4double IonisationEnergy(G4int level)
G4double LowEnergyLimit() const
const std::vector< double > * GetNumMolPerVolTableFor(const G4Material *) const
Retrieve a table of molecular densities (number of molecules per unit volume) in the G4 unit system f...
const std::vector< G4double > * fpWaterDensity
G4double ProposedSampledEnergy(G4ParticleDefinition *particle, G4double k, G4int ionizationLevelIndex)
static constexpr double m
void SetDeexcitationFlag(G4bool val)
G4ParticleDefinition * GetDefinition() const
void GenerateParticles(std::vector< G4DynamicParticle * > *secVect, const G4AtomicShell *, G4int Z, G4int coupleIndex)
const XML_Char int const XML_Char * value
static G4Proton * ProtonDefinition()
static constexpr double electron_mass_c2
static G4DNAMolecularMaterial * Instance()
G4double CorrectionFactor(G4ParticleDefinition *particleDefinition, G4double k, G4int shell)
void ProposeMomentumDirection(G4double Px, G4double Py, G4double Pz)
void CreateWaterMolecule(ElectronicModification, G4int, const G4Track *)
std::map< G4double, G4double > lowEnergyLimitOfModelForA
G4double R(G4double t, G4double energyTransferred, G4double slaterEffectiveChg, G4double shellNumber)
virtual G4ThreeVector & SampleDirectionForShell(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, G4int shellID, const G4Material *)
static constexpr double eV
void SetAngularDistribution(G4VEmAngularDistribution *)
const G4Track * GetCurrentTrack() const
G4double slaterEffectiveCharge[3]
static G4Electron * Electron()
static constexpr double eplus
std::map< G4double, G4double > lowEnergyLimitForA
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
G4double Sum(G4double energy, const G4String &particle)
G4ParticleDefinition * GetIon(const G4String &name)
G4DNARuddIonisationExtendedModel(const G4ParticleDefinition *p=0, const G4String &nam="DNARuddIonisationExtendedModel")
void SetLowEnergyLimit(G4double)
static MCTruthManager * instance
G4int GetLeptonNumber() const
static G4DNAGenericIonsManager * Instance(void)
G4int GetAtomicMass() const
G4double GetKineticEnergy() const
virtual G4double FindValue(G4double e, G4int componentId=0) const
static constexpr double cm
G4GLOB_DLL std::ostream G4cout
std::map< G4String, G4double, std::less< G4String > > lowEnergyLimit
virtual const G4VEMDataSet * GetComponent(G4int componentId) const
static G4LossTableManager * Instance()
virtual ~G4DNARuddIonisationExtendedModel()
G4ParticleChangeForGamma * fParticleChangeForGamma
G4double RandomizeEjectedElectronEnergy(G4ParticleDefinition *particleDefinition, G4double incomingParticleEnergy, G4int shell)
std::map< G4String, G4double, std::less< G4String > > highEnergyLimit
G4VEmAngularDistribution * GetAngularDistribution()
const G4Material * GetMaterial() const
G4ParticleDefinition * GetIon(G4int Z, G4int A, G4int lvl=0)
G4ParticleChangeForGamma * GetParticleChangeForGamma()
void ProposeLocalEnergyDeposit(G4double anEnergyPart)
G4double RejectionFunction(G4ParticleDefinition *particle, G4double k, G4double proposed_ws, G4int ionizationLevelIndex)
virtual void Initialise(const G4ParticleDefinition *, const G4DataVector &)
G4double bindingEnergy(G4int A, G4int Z)
G4double HighEnergyLimit() const
void ProposeTrackStatus(G4TrackStatus status)
G4int RandomSelect(G4double energy, const G4String &particle)
const G4DynamicParticle * GetDynamicParticle() const
static G4DNAChemistryManager * Instance()
virtual G4double FindValue(G4double x, G4int componentId=0) const =0