70 const G4int shell, FuncParams& par)
75 = { 12.60 * eV, 14.70 * eV, 18.40 * eV, 32.20 * eV, 540.0 * eV };
78 G4double A1{1.02}, B1{82.0},
C1{0.45}, D1{-0.80}, E1{0.38}, A2{1.07},
80 C2{0.60}, D2{0.04}, alpha_const{0.64};
82 auto Bj_energy = Bj[shell];
87 A1 = 1.25; B1 = 0.5;
C1 = 1.00; D1 = 1.00; E1 = 3.00;
88 A2 = 1.10; B2 = 1.30;
C2 = 1.00; D2 = 0.00;
94 const auto tau = ekin * electron_mass_c2 / mass;
101 constexpr G4double xxx = 5.447761194E-02 * MeV;
104 v2 = tau / Bj_energy;
105 beta2 = 2.0 * tau / electron_mass_c2;
108 v2 = (0.5 * electron_mass_c2 / Bj_energy)
109 * (1.0 - (1.0 / std::pow((1.0 + (tau / electron_mass_c2)), 2.0)));
110 beta2 = 1.0 - 1.0 / std::pow((1.0 + (tau / electron_mass_c2 / A_ion)), 2.0);
113 const auto v = std::sqrt(v2);
114 const auto wc = 4.0 * v2 - 2.0 * v - (Ry / (4.0 * Bj_energy));
116 const auto L1 = (
C1 * std::pow(v, D1)) / (1.0 + E1 * std::pow(v, (D1 + 4.0)));
117 const auto L2 =
C2 * std::pow(v, D2);
118 const auto H1 = (A1 *
G4Log(1.0 + v2)) / (v2 + (B1 / v2));
119 const auto H2 = (A2 / v2) + (B2 /(v2 * v2));
120 const auto F1 = L1 + H1;
121 const auto F2 = (L2 * H2) / (L2 + H2);
126 if (ekin <= 0.1 * mass) {
128 max_energy = 4.0 * (electron_mass_c2 / mass) * ekin;
131 auto gamma = 1.0 / std::sqrt(1.0 - beta2);
132 max_energy = 2.0 * electron_mass_c2 * (gamma * gamma - 1.0)
133 / (1.0 + 2.0 * gamma * (electron_mass_c2 / mass)
134 + std::pow(electron_mass_c2 / mass, 2.0));
137 const auto wmax = max_energy / Bj_energy;
138 auto c = wmax * (F2 * wmax+ F1 * (2.0 + wmax))
139 / (2.0 * (1.0 + wmax) * (1.0 + wmax));
142 par.Bj_energy = Bj_energy;
143 par.alpha_const = alpha_const;
144 par.beta_squared = beta2;
146 par.correction_factor = 1.0;
156 const FuncParams& par,
G4double proposed_ws)
159 const G4double Gj[5] = { 0.99, 1.11, 1.11, 0.52, 1.0 };
161 proposed_ws /= par.Bj_energy;
163 auto rejection_term = 1.0 +
G4Exp(par.alpha_const * (proposed_ws - par.wc)
165 rejection_term = (1.0 / rejection_term) * par.correction_factor * Gj[shell];
170 return rejection_term;
176 auto x = 100.0 * std::sqrt(par.beta_squared) / std::pow(Z, 0.6666667);
177 auto zeff = Z * (1.0 -
G4Exp(x * (-1.316 + x * (0.112 - 0.0650 * x))));
179 rejection_term *= (zeff * zeff);
181 return rejection_term;
187 rejection_term *= (zeff * zeff);
189 return rejection_term;
194G4double proposed_sampled_energy(
const FuncParams& par)
198 auto proposed_ws = par.c * (par.F1 * par.F1 * par.c
199 + 2.0 * rval * (par.F2 - par.F1));
201 proposed_ws = -par.F1 * par.c + 2.0 * rval + std::sqrt(proposed_ws);
203 proposed_ws /= (par.c * (par.F1 + par.F2) - 2.0 * rval);
205 proposed_ws *= par.Bj_energy;
249 for (
const auto& x :
xs_tab_) {
251 if (table) {
delete table; }
260 G4cout <<
"Calling G4DNADoubleIonisationModel::Initialise()" <<
G4endl;
267 constexpr G4double kScaleFactor = 1.0 * m * m;
272 G4String alpha_param_file{
"dna/multipleionisation_alphaparam_champion.dat"};
278 const auto& proton =
proton_def_->GetParticleName();
285 xs_proton->LoadData(
"dna/sigma_ionisation_p_rudd");
293 alpha_param_file =
"dna/multipleionisation_alphaparam_p.dat";
303 const auto& alpha =
alpha_def_->GetParticleName();
310 xs_alpha->LoadData(
"dna/sigma_ionisation_alphaplusplus_rudd");
318 alpha_param_file =
"dna/multipleionisation_alphaparam_alphaplusplus.dat";
328 const auto& carbon =
carbon_def_->GetParticleName();
335 xs_carbon->LoadData(
"dna/sigma_ionisation_c_rudd");
343 alpha_param_file =
"dna/multipleionisation_alphaparam_c.dat";
355 G4cout <<
"G4DNADoubleIonisationModel is initialized " <<
G4endl
379 EnergyLimitTable::iterator itr =
elow_tab_.find(pname);
380 if (itr !=
elow_tab_.end()) { elim = itr->second; }
390 EnergyLimitTable::iterator itr =
eupp_tab_.find(pname);
391 if (itr !=
eupp_tab_.end()) { elim = itr->second; }
403 G4cout <<
"Calling G4DNADoubleIonisationModel::CrossSectionPerVolume()"
421 if (ekin <= upp_energy_lim) {
423 if (ekin < low_energy_lim) { ekin = low_energy_lim; }
425 CrossSectionDataTable::iterator pos =
xs_tab_.find(pname);
427 G4Exception(
"G4DNADoubleIonisationModel::CrossSectionPerVolume",
429 "Model not applicable to particle type.");
433 if (table !=
nullptr) {
442 std::stringstream msg;
444 msg <<
"----------------------------------------------------------------\n";
445 msg <<
" G4DNADoubleIonisationModel - XS INFO START\n";
446 msg <<
" - Kinetic energy(eV): " << ekin/eV <<
", Particle : "
448 msg <<
" - Cross section per water molecule (cm^2): "
449 << sigma / cm / cm <<
"\n";
450 msg <<
" - Cross section per water molecule (cm^-1): "
451 << sigma * water_dens / (1.0 / cm) <<
"\n";
452 msg <<
" G4DNADoubleIonisationModel - XS INFO END\n";
453 msg <<
"----------------------------------------------------------------\n";
459 return (sigma * water_dens);
478 auto sample_electron_direction = [
this](
486 auto costh = std::cos(_theta);
487 auto sinth = std::sqrt((1.0 - costh) * (1.0 + costh));
488 locdir.
set(sinth * std::cos(_phi), sinth * std::sin(_phi), costh);
494 dp, _ekin2, _Z, _ioni_shell, mcc->GetMaterial());
495 _theta = locdir.
theta();
503 constexpr G4int Z = 8;
504 auto delta_dir = sample_electron_direction(
505 particle, ekin2, Z, ioni_shell, couple, theta, phi);
511 if (!
atom_deex_ || ioni_shell != 4) {
return ekin2; }
517 const auto shell =
atom_deex_->GetAtomicShell(Z, k_shell);
521 const auto num_sec_init = vsec->size();
524 atom_deex_->GenerateParticles(vsec, shell, Z, 0, 0);
528 const auto num_sec_final = vsec->size();
530 if (num_sec_final == num_sec_init) {
return ekin2; }
532 for (
auto i = num_sec_init; i < num_sec_final; i++) {
534 auto e = ((*vsec)[i])->GetKineticEnergy();
537 if (shell_energy < e) {
564 G4cout <<
"Calling SampleSecondaries() of G4DNADoubleIonisationModel"
583 if (ekin < low_energy_lim) {
591 constexpr G4int kNumSecondaries = 2;
592 constexpr G4double kDeltaTheta = pi;
594 G4int ioni_shell[kNumSecondaries];
595 G4double shell_energy[kNumSecondaries];
599 for (
G4int i = 0; i < kNumSecondaries; i++) {
601 shell_energy[i] = ::water_structure.IonisationEnergy(ioni_shell[i]);
602 tot_ioni_energy += shell_energy[i];
610 G4double theta{0.0}, phi{0.0}, tot_ekin2{0.0};
611 for (
G4int i = 0; i < kNumSecondaries; i++) {
613 theta, phi, shell_energy[i]);
614 theta += kDeltaTheta;
619 G4Exception(
"G4DNADoubleIonisatioModel::SampleSecondaries()",
628 const auto scattered_energy = ekin - tot_ioni_energy - tot_ekin2;
631 tot_ioni_energy = shell_energy[0] + shell_energy[1];
661 ::setup_rejection_function(pdef, ekin, shell, par);
665 for (
G4double en = 0.0; en < 20.0; en += 1.0) {
666 val = ::rejection_function(pdef, shell, par, en);
667 if (val <= emax) {
continue; }
674 proposed_energy = ::proposed_sampled_energy(par);
676 val = ::rejection_function(pdef, shell, par, proposed_energy);
677 }
while (rand > val);
679 return proposed_energy;
692 CrossSectionDataTable::iterator pos =
xs_tab_.find(pname);
695 G4Exception(
"G4DNADoubleIonisationModel::RandomSelect",
"em0002",
701 if (table !=
nullptr) {
706 auto* valuesBuffer =
new G4double[num_component];
708 auto shell = num_component;
715 value += valuesBuffer[shell];
720 shell = num_component;
724 if (valuesBuffer[shell] > value) {
725 delete [] valuesBuffer;
728 value -= valuesBuffer[shell];
731 delete [] valuesBuffer;
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
G4double G4Log(G4double x)
CLHEP::Hep3Vector G4ThreeVector
G4GLOB_DLL std::ostream G4cout
void set(double x, double y, double z)
Hep3Vector & rotateUz(const Hep3Vector &)
size_t NumberOfComponents() const override
const G4VEMDataSet * GetComponent(G4int componentId) const override
G4double FindValue(G4double e, G4int componentId=0) const override
G4DNAMultipleIonisationManager * mioni_manager_
G4int RandomSelect(G4double energy, G4double scale_param, const G4String &pname)
void Initialise(const G4ParticleDefinition *particle, const G4DataVector &) override
~G4DNADoubleIonisationModel() override
G4double RandomizeEjectedElectronEnergy(G4ParticleDefinition *pdef, G4double ekin, G4int shell)
G4VAtomDeexcitation * atom_deex_
void SampleSecondaries(std::vector< G4DynamicParticle * > *vsec, const G4MaterialCutsCouple *couple, const G4DynamicParticle *particle, G4double, G4double) override
std::map< G4double, G4double > model_elow_tab_
G4ParticleDefinition * proton_def_
G4DNADoubleIonisationModel(const G4ParticleDefinition *p=nullptr, const G4String &model_name="G4DNADoubleIonisationModel")
G4ParticleDefinition * carbon_def_
G4double GetUppEnergyLimit(const G4String &pname)
EnergyLimitTable eupp_tab_
G4double GetLowEnergyLimit(const G4String &pname)
G4double GenerateSecondaries(std::vector< G4DynamicParticle * > *vsec, const G4MaterialCutsCouple *couple, const G4DynamicParticle *particle, G4int ioni_shell, G4double &theta, G4double &phi, G4double &shell_energy)
G4ParticleDefinition * alpha_def_
EnergyLimitTable elow_tab_
G4bool use_champion_param_
const std::vector< G4double > * water_density_
G4double CrossSectionPerVolume(const G4Material *material, const G4ParticleDefinition *pdef, G4double ekin, G4double, G4double) override
G4ParticleChangeForGamma * particle_change_
G4double energy_threshold_
CrossSectionDataTable xs_tab_
static G4DNAGenericIonsManager * Instance()
G4ParticleDefinition * GetIon(const G4String &name)
const std::vector< G4double > * GetNumMolPerVolTableFor(const G4Material *) const
Retrieve a table of molecular densities (number of molecules per unit volume) in the G4 unit system f...
static G4DNAMolecularMaterial * Instance()
G4double IonisationEnergy(G4int level)
const G4ThreeVector & GetMomentumDirection() const
G4ParticleDefinition * GetDefinition() const
G4double GetKineticEnergy() const
static G4Electron * Electron()
static G4GenericIon * GenericIonDefinition()
G4ParticleDefinition * GetIon(G4int Z, G4int A, G4int lvl=0)
static G4IonTable * GetIonTable()
static G4LossTableManager * Instance()
G4VAtomDeexcitation * AtomDeexcitation()
std::size_t GetIndex() const
static G4Material * GetMaterial(const G4String &name, G4bool warning=true)
G4int GetAtomicNumber() const
G4double GetPDGMass() const
G4int GetAtomicMass() const
G4int GetLeptonNumber() const
G4double GetPDGCharge() const
const G4String & GetParticleName() const
static G4Proton * ProtonDefinition()
virtual G4double FindValue(G4double x, G4int componentId=0) const =0
virtual G4ThreeVector & SampleDirectionForShell(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, G4int shellID, const G4Material *)
void SetHighEnergyLimit(G4double)
G4VEmAngularDistribution * GetAngularDistribution()
G4ParticleChangeForGamma * GetParticleChangeForGamma()
G4double LowEnergyLimit() const
G4double HighEnergyLimit() const
void SetLowEnergyLimit(G4double)
void SetDeexcitationFlag(G4bool val)
G4VEmModel(const G4String &nam)
void SetAngularDistribution(G4VEmAngularDistribution *)