197const G4double G4NucleiModel::small = 1.0e-9;
198const G4double G4NucleiModel::large = 1000.;
201const G4double G4NucleiModel::piTimes4thirds = pi*4./3.;
204const G4double G4NucleiModel::alfa3[3] = { 0.7, 0.3, 0.01 };
205const G4double G4NucleiModel::alfa6[6] = { 0.9, 0.6, 0.4, 0.2, 0.1, 0.05 };
208const G4double G4NucleiModel::pion_vp = 0.007;
209const G4double G4NucleiModel::pion_vp_small = 0.007;
210const G4double G4NucleiModel::kaon_vp = 0.015;
211const G4double G4NucleiModel::hyperon_vp = 0.030;
221 0.0, 0.0024, 0.0032, 0.0042, 0.0056, 0.0075, 0.01, 0.024, 0.075, 0.1,
222 0.13, 0.18, 0.24, 0.32, 0.42, 0.56, 0.75, 1.0, 1.3, 1.8,
223 2.4, 3.2, 4.2, 5.6, 7.5, 10.0, 13.0, 18.0, 24.0, 32.0 };
226 0.0, 0.7, 2.0, 2.2, 2.1, 1.8, 1.3, 0.4, 0.098, 0.071,
227 0.055, 0.055, 0.065, 0.045, 0.017, 0.007, 2.37e-3, 6.14e-4, 1.72e-4, 4.2e-5,
228 1.05e-5, 3.0e-6, 7.0e-7, 1.3e-7, 2.3e-8, 3.2e-9, 4.9e-10, 0.0, 0.0, 0.0 };
234 : verboseLevel(0), nuclei_radius(0.), nuclei_volume(0.), number_of_zones(0),
235 A(0), Z(0), theNucleus(0), neutronNumber(0), protonNumber(0),
236 neutronNumberCurrent(0), protonNumberCurrent(0), current_nucl1(0),
237 current_nucl2(0), dinucleonDensityScale(1.0), gammaQDinterp(kebins),
240 skinDepth(0.611207*radiusUnits),
248 potentialThickness(1.0),
252 : verboseLevel(0), nuclei_radius(0.), nuclei_volume(0.), number_of_zones(0),
253 A(0), Z(0), theNucleus(0), neutronNumber(0), protonNumber(0),
254 neutronNumberCurrent(0), protonNumberCurrent(0), current_nucl1(0),
255 current_nucl2(0), dinucleonDensityScale(1.0), gammaQDinterp(kebins),
258 skinDepth(0.611207*radiusUnits),
266 potentialThickness(1.0),
272 : verboseLevel(0), nuclei_radius(0.), nuclei_volume(0.), number_of_zones(0),
273 A(0), Z(0), theNucleus(0), neutronNumber(0), protonNumber(0),
274 neutronNumberCurrent(0), protonNumberCurrent(0), current_nucl1(0),
275 current_nucl2(0), dinucleonDensityScale(1.0), gammaQDinterp(kebins),
278 skinDepth(0.611207*radiusUnits),
286 potentialThickness(1.0),
300 const std::vector<G4ThreeVector>* hitPoints) {
301 neutronNumberCurrent = neutronNumber - nHitNeutrons;
302 protonNumberCurrent = protonNumber - nHitProtons;
305 if (!hitPoints || !hitPoints->empty()) collisionPts.clear();
306 else collisionPts = *hitPoints;
318 G4cout <<
" >>> G4NucleiModel::generateModel A " << a <<
" Z " << z
323 if (a == A && z == Z) {
324 if (verboseLevel > 1)
G4cout <<
" model already generated" << z <<
G4endl;
334 neutronNumber = A - Z;
338 if (verboseLevel > 3) {
339 G4cout <<
" crossSectionUnits = " << crossSectionUnits <<
G4endl
340 <<
" radiusUnits = " << radiusUnits <<
G4endl
341 <<
" skinDepth = " << skinDepth <<
G4endl
342 <<
" radiusScale = " << radiusScale <<
G4endl
343 <<
" radiusScale2 = " << radiusScale2 <<
G4endl
344 <<
" radiusForSmall = " << radiusForSmall <<
G4endl
345 <<
" radScaleAlpha = " << radScaleAlpha <<
G4endl
346 <<
" fermiMomentum = " << fermiMomentum <<
G4endl
347 <<
" piTimes4thirds = " << piTimes4thirds <<
G4endl;
351 if (A>4) nuclearRadius = radiusScale*
G4cbrt(A) + radiusScale2/
G4cbrt(A);
352 else nuclearRadius = radiusForSmall * (A==4 ? radScaleAlpha : 1.);
355 number_of_zones = (A < 5) ? 1 : (A < 100) ? 3 : 6;
358 binding_energies.clear();
359 nucleon_densities.clear();
360 zone_potentials.clear();
361 fermi_momenta.clear();
363 zone_volumes.clear();
374 const std::vector<G4double> vp(number_of_zones, (A>4)?pion_vp:pion_vp_small);
375 const std::vector<G4double> kp(number_of_zones, kaon_vp);
376 const std::vector<G4double> hp(number_of_zones, hyperon_vp);
378 zone_potentials.push_back(std::move(vp));
379 zone_potentials.push_back(std::move(kp));
380 zone_potentials.push_back(std::move(hp));
384 nuclei_radius = zone_radii.back();
385 nuclei_volume = std::accumulate(zone_volumes.begin(),zone_volumes.end(),0.);
394 if (verboseLevel > 1)
395 G4cout <<
" >>> G4NucleiModel::fillBindingEnergies" <<
G4endl;
401 binding_energies.push_back(std::fabs(
bindingEnergy(A-1,Z-1)-dm)/GeV);
402 binding_energies.push_back(std::fabs(
bindingEnergy(A-1,Z)-dm)/GeV);
408 if (verboseLevel > 1)
409 G4cout <<
" >>> G4NucleiModel::fillZoneRadii" <<
G4endl;
411 G4double skinRatio = nuclearRadius/skinDepth;
415 zone_radii.push_back(nuclearRadius);
419 G4double rSq = nuclearRadius * nuclearRadius;
420 G4double gaussRadius = std::sqrt(rSq * (1.0 - 1.0/A) + 6.4);
423 for (
G4int i = 0; i < number_of_zones; i++) {
425 zone_radii.push_back(gaussRadius * y);
428 }
else if (A < 100) {
430 for (
G4int i = 0; i < number_of_zones; i++) {
432 zone_radii.push_back(nuclearRadius + skinDepth * y);
437 for (
G4int i = 0; i < number_of_zones; i++) {
439 zone_radii.push_back(nuclearRadius + skinDepth * y);
448 if (verboseLevel > 1)
449 G4cout <<
" >>> G4NucleiModel::fillZoneVolumes" <<
G4endl;
455 tot_vol = zone_radii[0]*zone_radii[0]*zone_radii[0];
456 zone_volumes.push_back(tot_vol*piTimes4thirds);
461 PotentialType usePotential = (A < 12) ? Gaussian : WoodsSaxon;
463 for (
G4int i = 0; i < number_of_zones; i++) {
464 if (usePotential == WoodsSaxon) {
472 v1[i] = zone_radii[i]*zone_radii[i]*zone_radii[i];
473 if (i > 0) v1[i] -= zone_radii[i-1]*zone_radii[i-1]*zone_radii[i-1];
475 zone_volumes.push_back(v1[i]*piTimes4thirds);
483 if (verboseLevel > 1)
484 G4cout <<
" >>> G4NucleiModel::fillZoneVolumes(" << type <<
")" <<
G4endl;
491 const G4double dm = binding_energies[type-1];
493 rod.clear(); rod.reserve(number_of_zones);
494 pf.clear(); pf.reserve(number_of_zones);
495 vz.clear(); vz.reserve(number_of_zones);
497 G4int nNucleons = (type==
proton) ? protonNumber : neutronNumber;
498 G4double dd0 = nNucleons / tot_vol / piTimes4thirds;
500 for (
G4int i = 0; i < number_of_zones; i++) {
505 vz.push_back(0.5 * pff * pff / mass + dm);
508 nucleon_densities.push_back(rod);
509 fermi_momenta.push_back(pf);
510 zone_potentials.push_back(vz);
516 if (verboseLevel > 1) {
517 G4cout <<
" >>> G4NucleiModel::zoneIntegralWoodsSaxon" <<
G4endl;
521 const G4int itry_max = 1000;
523 G4double skinRatio = nuclearRadius / skinDepth;
536 while (itry < itry_max) {
543 for (
G4int i = 0; i < jc; i++) {
545 fi += r * (r + d2) / (1.0 +
G4Exp(r));
548 fun = 0.5 * fun1 + fi * dr;
550 if (std::fabs((fun - fun1) / fun) <=
epsilon)
break;
557 if (verboseLevel > 2 && itry == itry_max)
558 G4cout <<
" zoneIntegralWoodsSaxon-> n iter " << itry_max <<
G4endl;
560 G4double skinDepth3 = skinDepth*skinDepth*skinDepth;
562 return skinDepth3 * (fun + skinRatio*skinRatio*
G4Log((1.0 +
G4Exp(-r1)) / (1.0 +
G4Exp(-r2))));
569 if (verboseLevel > 1) {
570 G4cout <<
" >>> G4NucleiModel::zoneIntegralGaussian" <<
G4endl;
573 G4double gaussRadius = std::sqrt(nucRad*nucRad * (1.0 - 1.0/A) + 6.4);
576 const G4int itry_max = 1000;
588 while (itry < itry_max) {
594 for (
G4int i = 0; i < jc; i++) {
596 fi += r * r *
G4Exp(-r * r);
599 fun = 0.5 * fun1 + fi * dr;
601 if (std::fabs((fun - fun1) / fun) <=
epsilon)
break;
608 if (verboseLevel > 2 && itry == itry_max)
609 G4cerr <<
" zoneIntegralGaussian-> n iter " << itry_max <<
G4endl;
611 return gaussRadius*gaussRadius*gaussRadius * fun;
616 if (verboseLevel > 1) {
620 G4cout <<
" nuclei model for A " << A <<
" Z " << Z <<
G4endl
621 <<
" proton binding energy " << binding_energies[0]
622 <<
" neutron binding energy " << binding_energies[1] <<
G4endl
623 <<
" Nuclei radius " << nuclei_radius <<
" volume " << nuclei_volume
624 <<
" number of zones " << number_of_zones <<
G4endl;
626 for (
G4int i = 0; i < number_of_zones; i++)
627 G4cout <<
" zone " << i+1 <<
" radius " << zone_radii[i]
628 <<
" volume " << zone_volumes[i] <<
G4endl
629 <<
" protons: density " <<
getDensity(1,i) <<
" PF " <<
631 <<
" neutrons: density " <<
getDensity(2,i) <<
" PF " <<
640 if (ip < 3 && izone < number_of_zones) {
641 G4double pfermi = fermi_momenta[ip - 1][izone];
644 ekin = std::sqrt(pfermi*pfermi + mass*mass) - mass;
661 if (verboseLevel > 1) {
662 G4cout <<
" >>> G4NucleiModel::generateNucleon" <<
G4endl;
673 if (verboseLevel > 1) {
674 G4cout <<
" >>> G4NucleiModel::generateQuasiDeuteron" <<
G4endl;
688 if (type1*type2 ==
pro*
pro) dtype = 111;
689 else if (type1*type2 ==
pro*
neu) dtype = 112;
690 else if (type1*type2 ==
neu*
neu) dtype = 122;
698 if (verboseLevel > 1) {
699 G4cout <<
" >>> G4NucleiModel::generateInteractionPartners" <<
G4endl;
710 if (zone == number_of_zones) {
711 r_in = nuclei_radius;
713 }
else if (zone == 0) {
715 r_out = zone_radii[0];
717 r_in = zone_radii[zone - 1];
718 r_out = zone_radii[zone];
723 if (verboseLevel > 2) {
725 G4cout <<
" r_in " << r_in <<
" r_out " << r_out <<
" path " << path
731 G4cerr <<
" generateInteractionPartners-> negative path length" <<
G4endl;
735 if (std::fabs(path) < small) {
737 if (verboseLevel > 3)
738 G4cout <<
" generateInteractionPartners-> zero path" <<
G4endl;
744 if (zone >= number_of_zones)
745 zone = number_of_zones-1;
750 for (
G4int ip = 1; ip < 3; ip++) {
752 if (ip==
proton && protonNumberCurrent < 1)
continue;
753 if (ip==
neutron && neutronNumberCurrent < 1)
continue;
761 if (path<small || spath < path) {
762 if (verboseLevel > 3) {
770 if (verboseLevel > 2) {
776 if (verboseLevel > 2) {
777 G4cout <<
" trying quasi-deuterons with bullet: "
788 if (protonNumberCurrent >= 2 && ptype !=
pip) {
790 if (verboseLevel > 2)
791 G4cout <<
" ptype=" << ptype <<
" using pp target\n" << ppd <<
G4endl;
794 tot_invmfp += invmfp;
795 acsecs.push_back(invmfp);
796 qdeutrons.push_back(ppd);
800 if (protonNumberCurrent >= 1 && neutronNumberCurrent >= 1) {
802 if (verboseLevel > 2)
803 G4cout <<
" ptype=" << ptype <<
" using np target\n" << npd <<
G4endl;
806 tot_invmfp += invmfp;
807 acsecs.push_back(invmfp);
808 qdeutrons.push_back(npd);
812 if (neutronNumberCurrent >= 2 && ptype !=
pim && ptype !=
mum) {
814 if (verboseLevel > 2)
815 G4cout <<
" ptype=" << ptype <<
" using nn target\n" << nnd <<
G4endl;
818 tot_invmfp += invmfp;
819 acsecs.push_back(invmfp);
820 qdeutrons.push_back(nnd);
824 if (verboseLevel > 2) {
825 for (std::size_t i=0; i<qdeutrons.size(); i++) {
826 G4cout <<
" acsecs[" << qdeutrons[i].getDefinition()->GetParticleName()
827 <<
"] " << acsecs[i];
832 if (tot_invmfp > small) {
835 if (path<small || apath < path) {
839 for (std::size_t i = 0; i < qdeutrons.size(); i++) {
842 if (verboseLevel > 2)
853 if (verboseLevel > 2) {
870 std::vector<G4CascadParticle>& outgoing_cparticles) {
871 if (verboseLevel > 1)
872 G4cout <<
" >>> G4NucleiModel::generateParticleFate" <<
G4endl;
874 if (verboseLevel > 2)
G4cout <<
" cparticle: " << cparticle <<
G4endl;
877#ifdef G4CASCADE_CHECK_ECONS
882 outgoing_cparticles.clear();
887 G4cerr <<
" generateParticleFate-> got empty interaction-partners list "
895 if (verboseLevel > 1)
896 G4cout <<
" no interactions; moving to next zone" <<
G4endl;
901 outgoing_cparticles.push_back(cparticle);
903 if (verboseLevel > 2)
G4cout <<
" next zone \n" << cparticle <<
G4endl;
912 if (verboseLevel > 1)
913 G4cout <<
" processing " << npart-1 <<
" possible interactions" <<
G4endl;
917 G4bool no_interaction =
true;
920 for (std::size_t i=0; i<npart-1; ++i) {
925 if (verboseLevel > 3) {
927 G4cout <<
" target " << target.
type() <<
" bullet " << bullet.
type()
933 G4int massNumberCurrent = protonNumberCurrent+neutronNumberCurrent;
934 theEPCollider->
setNucleusState(massNumberCurrent, protonNumberCurrent);
935 theEPCollider->
collide(&bullet, &target, EPCoutput);
938 if (EPCoutput.numberOfOutgoingParticles() == 0)
break;
940 if (verboseLevel > 2) {
941 EPCoutput.printCollisionOutput();
942#ifdef G4CASCADE_CHECK_ECONS
943 balance.
collide(&bullet, &target, EPCoutput);
949 std::vector<G4InuclElementaryParticle>& outgoing_particles =
950 EPCoutput.getOutgoingParticles();
952 if (!
passFermi(outgoing_particles, zone))
continue;
959 collisionPts.push_back(new_position);
962 std::sort(outgoing_particles.begin(), outgoing_particles.end(),
965 if (verboseLevel > 2)
966 G4cout <<
" adding " << outgoing_particles.size()
967 <<
" output particles" <<
G4endl;
971 for (std::size_t ip = 0; ip < outgoing_particles.size(); ++ip) {
977 no_interaction =
false;
981#ifdef G4CASCADE_DEBUG_CHARGE
985 for (
G4int ip = 0; ip <
G4int(outgoing_particles.size()); ip++)
986 out_charge += outgoing_particles[ip].getCharge();
988 G4cout <<
" multiplicity " << outgoing_particles.size()
989 <<
" bul type " << bullet.
type()
990 <<
" targ type " << target.
type()
991 <<
"\n initial charge "
993 <<
" out charge " << out_charge <<
G4endl;
997 if (verboseLevel > 2)
1001 current_nucl1 = target.
type();
1003 if (verboseLevel > 2)
G4cout <<
" good absorption " <<
G4endl;
1004 current_nucl1 = (target.
type() - 100) / 10;
1005 current_nucl2 = target.
type() - 100 - 10 * current_nucl1;
1008 if (current_nucl1 == 1) {
1009 if (verboseLevel > 3)
G4cout <<
" decrement proton count" <<
G4endl;
1010 protonNumberCurrent--;
1012 if (verboseLevel > 3)
G4cout <<
" decrement neutron count" <<
G4endl;
1013 neutronNumberCurrent--;
1016 if (current_nucl2 == 1) {
1017 if (verboseLevel > 3)
G4cout <<
" decrement proton count" <<
G4endl;
1018 protonNumberCurrent--;
1019 }
else if (current_nucl2 == 2) {
1020 if (verboseLevel > 3)
G4cout <<
" decrement neutron count" <<
G4endl;
1021 neutronNumberCurrent--;
1027 if (no_interaction) {
1028 if (verboseLevel > 1)
G4cout <<
" no interaction " <<
G4endl;
1032 if (!prescatCP_G4MT_TLS_) {
1044 outgoing_cparticles.push_back(cparticle);
1047#ifdef G4CASCADE_CHECK_ECONS
1048 if (verboseLevel > 2) {
1049 balance.
collide(&prescatCP, 0, outgoing_cparticles);
1061 if (qdtype==
pn || qdtype==0)
1062 return (ptype==
pi0 || ptype==
pip || ptype==
pim || ptype==
gam || ptype==
mum);
1063 else if (qdtype==
pp)
1064 return (ptype==
pi0 || ptype==
pim || ptype==
gam || ptype==
mum);
1065 else if (qdtype==
nn)
1066 return (ptype==
pi0 || ptype==
pip || ptype==
gam);
1074 if (verboseLevel > 1) {
1079 for (
G4int i = 0; i <
G4int(particles.size()); i++) {
1080 if (!particles[i].
nucleon())
continue;
1082 G4int type = particles[i].type();
1083 G4double mom = particles[i].getMomModule();
1084 G4double pfermi = fermi_momenta[type-1][zone];
1086 if (verboseLevel > 2)
1087 G4cout <<
" type " << type <<
" p " << mom <<
" pf " << pfermi <<
G4endl;
1090 if (verboseLevel > 2)
G4cout <<
" rejected by Fermi" <<
G4endl;
1102 if (verboseLevel > 1)
1103 G4cout <<
" >>> G4NucleiModel::passTrailing " << hit_position <<
G4endl;
1106 for (
G4int i = 0; i <
G4int(collisionPts.size() ); i++) {
1107 dist = (collisionPts[i] - hit_position).mag();
1108 if (verboseLevel > 2)
G4cout <<
" dist " << dist <<
G4endl;
1109 if (dist < R_nucleon) {
1110 if (verboseLevel > 2)
G4cout <<
" rejected by Trailing" <<
G4endl;
1119 if (verboseLevel > 1) {
1120 G4cout <<
" >>> G4NucleiModel::boundaryTransition" <<
G4endl;
1126 if (verboseLevel)
G4cerr <<
" boundaryTransition-> in zone 0 " <<
G4endl;
1144 if (verboseLevel > 3) {
1145 G4cout <<
"Potentials for type " << type <<
" = "
1150 G4double qv = dv*dv + 2.0*dv*mom.
e() + pr*pr;
1156 G4double qperp = 2.0*pperp2*potentialThickness/r;
1158 if (verboseLevel > 3) {
1159 G4cout <<
" type " << type <<
" zone " << zone <<
" next " << next_zone
1160 <<
" qv " << qv <<
" dv " << dv <<
G4endl;
1163 G4bool adjustpperp =
false;
1167 if (qv <= 0.0 && qv+qperp <=0 ) {
1168 if (verboseLevel > 3)
G4cout <<
" reflects off boundary" <<
G4endl;
1173 }
else if (qv > 0.0) {
1174 if (verboseLevel > 3)
G4cout <<
" passes thru boundary" <<
G4endl;
1175 p1r = std::sqrt(qv);
1176 if (pr < 0.0) p1r = -p1r;
1181 if (verboseLevel > 3)
G4cout <<
" passes thru boundary due to angular momentum" <<
G4endl;
1182 p1r = smallish * pr;
1191 if (verboseLevel > 3) {
1192 G4cout <<
" prr " << prr <<
" delta px " << prr*pos.x() <<
" py "
1193 << prr*pos.y() <<
" pz " << prr*pos.z() <<
" mag "
1194 << std::fabs(prr*r) <<
G4endl;
1199 G4double new_pperp_mag = std::sqrt(std::max(0.0, pperp2 + qv - p1r*p1r) );
1201 mom.
setVect(old_pperp * new_pperp_mag/std::sqrt(pperp2));
1216 if (verboseLevel > 1)
1217 G4cout <<
" >>> G4NucleiModel::choosePointAlongTraj" <<
G4endl;
1229 if (verboseLevel > 3)
1230 G4cout <<
" pos " << pos <<
" phat " << phat <<
" rhat " << rhat <<
G4endl;
1235 if (prang < 1e-6) posout = -pos;
1239 if (verboseLevel > 3)
G4cout <<
" posrot " << posrot/deg <<
" deg";
1242 if (verboseLevel > 3)
G4cout <<
" posout " << posout <<
G4endl;
1247 G4double lenmid = (posout-pos).mag()/2.;
1249 G4int zoneout = number_of_zones-1;
1253 G4int ncross = (number_of_zones-zonemid)*2;
1255 if (verboseLevel > 3) {
1256 G4cout <<
" posmid " << posmid <<
" lenmid " << lenmid
1257 <<
" zoneout " << zoneout <<
" zonemid " << zonemid
1258 <<
" ncross " << ncross <<
G4endl;
1262 std::vector<G4double> wtlen(ncross,0.);
1263 std::vector<G4double> len(ncross,0.);
1267 for (i=0; i<ncross/2; i++) {
1268 G4int iz = zoneout-i;
1269 G4double ds = std::sqrt(zone_radii[iz]*zone_radii[iz]-r2mid);
1271 len[i] = lenmid - ds;
1272 len[ncross-1-i] = lenmid + ds;
1274 if (verboseLevel > 3) {
1275 G4cout <<
" i " << i <<
" iz " << iz <<
" ds " << ds
1276 <<
" len " << len[i] <<
G4endl;
1281 for (i=1; i<ncross; i++) {
1282 G4int iz = (i<ncross/2) ? zoneout-i+1 : zoneout-ncross+i+1;
1296 wtlen[i] = wtlen[i-1] + wt;
1298 if (verboseLevel > 3) {
1299 G4cout <<
" i " << i <<
" iz " << iz <<
" avg.mfp " << 1./invmfp
1300 <<
" dlen " << dlen <<
" wt " << wt <<
" wtlen " << wtlen[i]
1306 std::transform(wtlen.begin(), wtlen.end(), wtlen.begin(),
1307 std::bind(std::divides<G4double>(), std::placeholders::_1, wtlen.back()));
1309 if (verboseLevel > 3) {
1311 for (i=0; i<ncross; i++)
G4cout <<
" " << wtlen[i];
1317 G4long ir = std::upper_bound(wtlen.begin(),wtlen.end(),rand) - wtlen.begin();
1319 G4double frac = (rand-wtlen[ir-1]) / (wtlen[ir]-wtlen[ir-1]);
1320 G4double drand = (1.-frac)*len[ir-1] + frac*len[ir];
1322 if (verboseLevel > 3) {
1323 G4cout <<
" rand " << rand <<
" ir " << ir <<
" frac " << frac
1324 <<
" drand " << drand <<
G4endl;
1327 pos += drand * phat;
1333 if (verboseLevel > 2) {
1335 <<
" @ " << pos <<
G4endl;
1353 if (verboseLevel > 1) {
1354 G4cout <<
" >>> G4NucleiModel::worthToPropagate" <<
G4endl;
1371 if (verboseLevel > 3) {
1374 <<
" potential=" << ekin_cut
1375 <<
" : worth? " << worth <<
G4endl;
1384 if (verboseLevel > 4) {
1385 G4cout <<
" >>> G4NucleiModel::getRatio " << ip <<
G4endl;
1402 dinucleonDensityScale = 1.0;
1416 const G4double num_LDA_QDs {(Levinger_LDA*Z*(A-Z))/A};
1421 for (
G4int zone = 0; zone < number_of_zones; ++zone) {
1428 dinucleonDensityScale = num_LDA_QDs/num_Naive_QDs;
1430 if (verboseLevel > 4) {
1431 G4cout <<
" >>> G4NucleiModel::setDinucleonDensityScale()" <<
G4endl;
1432 G4cout <<
" >>> Naive number of quasi-deuterons in nucleus ("
1433 << Z <<
", " << A <<
") = " << num_Naive_QDs <<
G4endl;
1434 G4cout <<
" >>> Number of quasi-deuterons expected from Levinger LDA is "
1435 << num_LDA_QDs <<
G4endl;
1436 G4cout <<
"Rescaling dinucleon densities by " << dinucleonDensityScale <<
G4endl;
1442 const G4double combinatoric_factor = 0.5;
1451 * dinucleonDensityScale * combinatoric_factor;
1455 * dinucleonDensityScale;
1459 * dinucleonDensityScale * combinatoric_factor;
1472 if (verboseLevel > 1) {
1473 G4cout <<
" >>> G4NucleiModel::initializeCascad(particle)" <<
G4endl;
1483 G4int zone = number_of_zones;
1500 G4cout <<
" >>> G4NucleiModel::initializeCascad(bullet,target,output)"
1504 const G4double max_a_for_cascad = 5.0;
1506 const G4double small_ekin = 1.0e-6;
1507 const G4double r_large2for3 = 62.0;
1510 const G4double r_large2for4 = 69.14;
1513 const G4int itry_max = 100;
1516 std::vector<G4CascadParticle>& casparticles = output.first;
1517 std::vector<G4InuclElementaryParticle>& particles = output.second;
1519 casparticles.clear();
1530 if (ab < max_a_for_cascad) {
1534 G4double ben = benb < bent ? bent : benb;
1540 while (casparticles.size() == 0 && itryg < itry_max) {
1545 coordinates.clear();
1551 coordinates.push_back(coord1);
1552 coordinates.push_back(-coord1);
1558 while (bad && itry < itry_max) {
1562 if (p*p / (p*p + 2079.36) / (p*p + 2079.36) > 1.2023e-4 *
G4UniformRand()
1563 && p*r > 312.0) bad =
false;
1566 if (itry == itry_max)
1567 if (verboseLevel > 2){
1568 G4cout <<
" deutron bullet generation-> itry = " << itry_max <<
G4endl;
1573 if (verboseLevel > 2){
1579 momentums.push_back(mom);
1581 momentums.push_back(-mom);
1590 while (badco && itry < itry_max) {
1591 if (itry > 0) coordinates.clear();
1595 for (i = 0; i < 2; i++) {
1600 while (itry1 < itry_max) {
1604 rho = std::sqrt(ss) *
G4Exp(-ss);
1606 if (rho > u && ss < s3max) {
1607 ss = r0forAeq3 * std::sqrt(ss);
1609 coordinates.push_back(coord1);
1611 if (verboseLevel > 2){
1618 if (itry1 == itry_max) {
1619 coord1.
set(10000.,10000.,10000.);
1620 coordinates.push_back(coord1);
1625 coord1 = -coordinates[0] - coordinates[1];
1626 if (verboseLevel > 2) {
1630 coordinates.push_back(coord1);
1632 G4bool large_dist =
false;
1634 for (i = 0; i < 2; i++) {
1635 for (
G4int j = i+1; j < 3; j++) {
1636 G4double r2 = (coordinates[i]-coordinates[j]).mag2();
1638 if (verboseLevel > 2) {
1639 G4cout <<
" i " << i <<
" j " << j <<
" r2 " << r2 <<
G4endl;
1642 if (r2 > r_large2for3) {
1649 if (large_dist)
break;
1652 if(!large_dist) badco =
false;
1659 G4double u = b1 + std::sqrt(b1 * b1 + b);
1662 while (badco && itry < itry_max) {
1664 if (itry > 0) coordinates.clear();
1668 for (i = 0; i < ab-1; i++) {
1672 while (itry1 < itry_max) {
1677 if (std::sqrt(ss) *
G4Exp(-ss) * (1.0 + ss/b) > u
1679 ss = r0forAeq4 * std::sqrt(ss);
1681 coordinates.push_back(coord1);
1683 if (verboseLevel > 2) {
1691 if (itry1 == itry_max) {
1692 coord1.
set(10000.,10000.,10000.);
1693 coordinates.push_back(coord1);
1699 for(
G4int j = 0; j < ab -1; j++) coord1 -= coordinates[j];
1701 coordinates.push_back(coord1);
1703 if (verboseLevel > 2){
1707 G4bool large_dist =
false;
1709 for (i = 0; i < ab-1; i++) {
1710 for (
G4int j = i+1; j < ab; j++) {
1712 G4double r2 = (coordinates[i]-coordinates[j]).mag2();
1714 if (verboseLevel > 2){
1715 G4cout <<
" i " << i <<
" j " << j <<
" r2 " << r2 <<
G4endl;
1718 if (r2 > r_large2for4) {
1725 if (large_dist)
break;
1728 if (!large_dist) badco =
false;
1733 G4cout <<
" can not generate the nucleons coordinates for a "
1736 casparticles.clear();
1745 for (
G4int i = 0; i < ab - 1; i++) {
1748 while(itry2 < itry_max) {
1754 p = std::sqrt(0.01953 * u);
1756 momentums.push_back(mom);
1762 if(itry2 == itry_max) {
1763 G4cout <<
" can not generate proper momentum for a "
1766 casparticles.clear();
1776 for(
G4int j=0; j< ab-1; j++) mom -= momentums[j];
1778 momentums.push_back(mom);
1786 for(i = 0; i <
G4int(coordinates.size()); i++) {
1787 G4double rp = coordinates[i].mag2();
1789 if(rp > rb) rb = rp;
1795 G4double rz = (nuclei_radius + rb) * s1;
1796 G4ThreeVector global_pos(rz*std::cos(phi), rz*std::sin(phi),
1797 -(nuclei_radius+rb)*std::sqrt(1.0-s1*s1));
1799 for (i = 0; i <
G4int(coordinates.size()); i++) {
1800 coordinates[i] += global_pos;
1804 raw_particles.clear();
1806 for (
G4int ipa = 0; ipa < ab; ipa++) {
1807 G4int knd = ipa < zb ? 1 : 2;
1817 for (ipart = raw_particles.begin(); ipart != raw_particles.end(); ipart++) {
1818 ipart->setMomentum(toTheBulletRestFrame.
backToTheLab(ipart->getMomentum()));
1823 for(
G4int ip = 0; ip <
G4int(raw_particles.size()); ip++) {
1827 G4double det = t0 * t0 + nuclei_radius * nuclei_radius
1828 - coordinates[ip].mag2();
1835 if(std::fabs(t1) <= std::fabs(t2)) {
1837 if(coordinates[ip].z() + mom.
z() * t1 / pmod <= 0.0) tr = t1;
1840 if(tr < 0.0 && t2 > 0.0) {
1842 if(coordinates[ip].z() + mom.
z() * t2 / pmod <= 0.0) tr = t2;
1848 if(coordinates[ip].z() + mom.
z() * t2 / pmod <= 0.0) tr = t2;
1851 if(tr < 0.0 && t1 > 0.0) {
1852 if(coordinates[ip].z() + mom.
z() * t1 / pmod <= 0.0) tr = t1;
1859 coordinates[ip] += mom.
vect()*tr / pmod;
1862 number_of_zones, large, 0));
1865 particles.push_back(raw_particles[ip]);
1870 if(casparticles.size() == 0) {
1873 G4cout <<
" can not generate proper distribution for " << itry_max
1879 if(verboseLevel > 2){
1882 G4cout <<
" cascad particles: " << casparticles.size() <<
G4endl;
1883 for(ip = 0; ip <
G4int(casparticles.size()); ip++)
1886 G4cout <<
" outgoing particles: " << particles.size() <<
G4endl;
1887 for(ip = 0; ip <
G4int(particles.size()); ip++)
1905 if (zone>=number_of_zones) zone = number_of_zones-1;
1912 dummy_convertor.setBullet(cparticle.
getParticle());
1913 dummy_convertor.setTarget(&target);
1914 dummy_convertor.toTheCenterOfMass();
1915 G4double ekin = dummy_convertor.getKinEnergyInTheTRS();
1921 if (verboseLevel > 2) {
1922 G4cout <<
" ip " << ip <<
" zone " << zone <<
" ekin " << ekin
1924 <<
" csec " << csec <<
G4endl;
1927 if (csec <= 0.)
return 0.;
1939 const G4double young_cut = std::sqrt(10.0) * 0.25;
1944 if (invmfp < small)
return spath;
1947 if (pw < -huge_num) pw = -huge_num;
1948 pw = 1.0 -
G4Exp(pw);
1950 if (verboseLevel > 2)
1951 G4cout <<
" mfp " << 1./invmfp <<
" pw " << pw <<
G4endl;
1956 if (cparticle.
young(young_cut, spath)) spath = large;
1958 if (verboseLevel > 2)
1959 G4cout <<
" spath " << spath <<
" path " << path <<
G4endl;
1970 G4cerr <<
"absorptionCrossSection() only valid for incident pions or gammas"
1981 if (ke < 0.3) csec = (0.1106 / std::sqrt(ke) - 0.8
1982 + 0.08 / ((ke-0.123)*(ke-0.123) + 0.0056) );
1983 else if (ke < 1.0) csec = 3.6735 * (1.0-ke)*(1.0-ke);
1987 csec = gammaQDinterp.interpolate(ke, gammaQDxsec) * gammaQDscale;
1990 if (csec < 0.0) csec = 0.0;
1992 if (verboseLevel > 2) {
1993 G4cout <<
" ekin " << ke <<
" abs. csec " << csec <<
" mb" <<
G4endl;
1996 return crossSectionUnits * csec;
2005 G4cerr <<
" unknown collison type = " << rtype <<
G4endl;
std::vector< G4InuclElementaryParticle >::iterator particleIterator
G4double epsilon(G4double density, G4double temperature)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
G4double G4Log(G4double x)
CLHEP::HepLorentzVector G4LorentzVector
CLHEP::Hep3Vector G4ThreeVector
G4GLOB_DLL std::ostream G4cerr
G4GLOB_DLL std::ostream G4cout
Hep3Vector cross(const Hep3Vector &) const
double angle(const Hep3Vector &) const
double dot(const Hep3Vector &) const
void set(double x, double y, double z)
Hep3Vector & rotate(double, const Hep3Vector &)
void setVect(const Hep3Vector &)
G4bool reflectedNow() const
G4int getGeneration() const
void updateZone(G4int izone)
void incrementCurrentPath(G4double npath)
const G4InuclElementaryParticle & getParticle() const
void updateParticleMomentum(const G4LorentzVector &mom)
void updatePosition(const G4ThreeVector &pos)
G4bool movingInsideNuclei() const
void propagateAlongThePath(G4double path)
G4LorentzVector getMomentum() const
G4bool young(G4double young_path_cut, G4double cpath) const
void incrementReflectionCounter()
G4int getCurrentZone() const
G4double getPathToTheNextZone(G4double rz_in, G4double rz_out)
const G4ThreeVector & getPosition() const
static const G4CascadeChannel * GetTable(G4int initialState)
virtual G4double getCrossSection(double ke) const =0
void collide(G4InuclParticle *bullet, G4InuclParticle *target, G4CollisionOutput &output)
void setNucleusState(G4int a, G4int z)
void collide(G4InuclParticle *bullet, G4InuclParticle *target, G4CollisionOutput &output)
G4bool quasi_deutron() const
static G4double getParticleMass(G4int type)
G4bool isNeutrino() const
G4double getKineticEnergy() const
G4double getEnergy() const
G4double getCharge() const
void toTheTargetRestFrame()
G4LorentzVector backToTheLab(const G4LorentzVector &mom) const
G4int getZone(G4double r) const
G4bool forceFirst(const G4CascadParticle &cparticle) const
G4double getRatio(G4int ip) const
G4double getDensity(G4int ip, G4int izone) const
G4CascadParticle initializeCascad(G4InuclElementaryParticle *particle)
G4bool worthToPropagate(const G4CascadParticle &cparticle) const
G4double generateInteractionLength(const G4CascadParticle &cparticle, G4double path, G4double invmfp) const
void generateParticleFate(G4CascadParticle &cparticle, G4ElementaryParticleCollider *theEPCollider, std::vector< G4CascadParticle > &cascade)
void setDinucleonDensityScale()
G4double inverseMeanFreePath(const G4CascadParticle &cparticle, const G4InuclElementaryParticle &target, G4int zone=-1)
void fillBindingEnergies()
G4double getCurrentDensity(G4int ip, G4int izone) const
std::pair< G4InuclElementaryParticle, G4double > partner
G4double fillZoneVolumes(G4double nuclearRadius)
G4InuclElementaryParticle generateNucleon(G4int type, G4int zone) const
void boundaryTransition(G4CascadParticle &cparticle)
G4double getVolume(G4int izone) const
G4double totalCrossSection(G4double ke, G4int rtype) const
G4double getPotential(G4int ip, G4int izone) const
G4double getFermiMomentum(G4int ip, G4int izone) const
G4bool passTrailing(const G4ThreeVector &hit_position)
static G4bool useQuasiDeuteron(G4int ptype, G4int qdtype=0)
void reset(G4int nHitNeutrons=0, G4int nHitProtons=0, const std::vector< G4ThreeVector > *hitPoints=0)
G4double absorptionCrossSection(G4double e, G4int type) const
void generateModel(G4InuclNuclei *nuclei)
G4InuclElementaryParticle generateQuasiDeuteron(G4int type1, G4int type2, G4int zone) const
G4double zoneIntegralGaussian(G4double ur1, G4double ur2, G4double nuclearRadius) const
G4bool passFermi(const std::vector< G4InuclElementaryParticle > &particles, G4int zone)
std::pair< std::vector< G4CascadParticle >, std::vector< G4InuclElementaryParticle > > modelLists
G4double getFermiKinetic(G4int ip, G4int izone) const
std::vector< partner > thePartners
G4double zoneIntegralWoodsSaxon(G4double ur1, G4double ur2, G4double nuclearRadius) const
void fillZoneRadii(G4double nuclearRadius)
G4LorentzVector generateNucleonMomentum(G4int type, G4int zone) const
G4bool isProjectile(const G4CascadParticle &cparticle) const
static G4bool sortPartners(const partner &p1, const partner &p2)
void fillPotentials(G4int type, G4double tot_vol)
void generateInteractionPartners(G4CascadParticle &cparticle)
void choosePointAlongTraj(G4CascadParticle &cparticle)
static G4Pow * GetInstance()
G4double A13(G4double A) const
virtual void setVerboseLevel(G4int verbose=0)
G4bool nucleon(G4int ityp)
G4LorentzVector generateWithFixedTheta(G4double ct, G4double p, G4double mass=0.)
G4double bindingEnergy(G4int A, G4int Z)
G4LorentzVector generateWithRandomAngles(G4double p, G4double mass=0.)
G4double G4cbrt(G4double x)