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

#include <G4NucleiModel.hh>

Public Types

typedef std::pair< std::vector< G4CascadParticle >, std::vector< G4InuclElementaryParticle > > modelLists
 

Public Member Functions

 G4NucleiModel ()
 
 G4NucleiModel (G4int a, G4int z)
 
 G4NucleiModel (G4InuclNuclei *nuclei)
 
virtual ~G4NucleiModel ()
 
void setVerboseLevel (G4int verbose)
 
void generateModel (G4InuclNuclei *nuclei)
 
void generateModel (G4int a, G4int z)
 
void reset (G4int nHitNeutrons=0, G4int nHitProtons=0, const std::vector< G4ThreeVector > *hitPoints=0)
 
void printModel () const
 
G4double getDensity (G4int ip, G4int izone) const
 
G4double getFermiMomentum (G4int ip, G4int izone) const
 
G4double getFermiKinetic (G4int ip, G4int izone) const
 
G4double getPotential (G4int ip, G4int izone) const
 
G4double getRadiusUnits () const
 
G4double getRadius () const
 
G4double getRadius (G4int izone) const
 
G4double getVolume (G4int izone) const
 
G4int getNumberOfZones () const
 
G4int getZone (G4double r) const
 
G4int getNumberOfNeutrons () const
 
G4int getNumberOfProtons () const
 
G4bool empty () const
 
G4bool stillInside (const G4CascadParticle &cparticle)
 
G4CascadParticle initializeCascad (G4InuclElementaryParticle *particle)
 
void initializeCascad (G4InuclNuclei *bullet, G4InuclNuclei *target, modelLists &output)
 
std::pair< G4int, G4intgetTypesOfNucleonsInvolved () const
 
void generateParticleFate (G4CascadParticle &cparticle, G4ElementaryParticleCollider *theEPCollider, std::vector< G4CascadParticle > &cascade)
 
G4bool forceFirst (const G4CascadParticle &cparticle) const
 
G4bool isProjectile (const G4CascadParticle &cparticle) const
 
G4bool worthToPropagate (const G4CascadParticle &cparticle) const
 
G4InuclElementaryParticle generateNucleon (G4int type, G4int zone) const
 
G4LorentzVector generateNucleonMomentum (G4int type, G4int zone) const
 
G4double absorptionCrossSection (G4double e, G4int type) const
 
G4double totalCrossSection (G4double ke, G4int rtype) const
 

Static Public Member Functions

static G4bool useQuasiDeuteron (G4int ptype, G4int qdtype=0)
 

Protected Types

typedef std::pair< G4InuclElementaryParticle, G4doublepartner
 

Protected Member Functions

G4bool passFermi (const std::vector< G4InuclElementaryParticle > &particles, G4int zone)
 
G4bool passTrailing (const G4ThreeVector &hit_position)
 
void boundaryTransition (G4CascadParticle &cparticle)
 
void choosePointAlongTraj (G4CascadParticle &cparticle)
 
G4InuclElementaryParticle generateQuasiDeuteron (G4int type1, G4int type2, G4int zone) const
 
void generateInteractionPartners (G4CascadParticle &cparticle)
 
void fillBindingEnergies ()
 
void fillZoneRadii (G4double nuclearRadius)
 
G4double fillZoneVolumes (G4double nuclearRadius)
 
void fillPotentials (G4int type, G4double tot_vol)
 
G4double zoneIntegralWoodsSaxon (G4double ur1, G4double ur2, G4double nuclearRadius) const
 
G4double zoneIntegralGaussian (G4double ur1, G4double ur2, G4double nuclearRadius) const
 
G4double getRatio (G4int ip) const
 
G4double getCurrentDensity (G4int ip, G4int izone) const
 
G4double inverseMeanFreePath (const G4CascadParticle &cparticle, const G4InuclElementaryParticle &target, G4int zone=-1)
 
G4double generateInteractionLength (const G4CascadParticle &cparticle, G4double path, G4double invmfp) const
 
void setDinucleonDensityScale ()
 

Static Protected Member Functions

static G4bool sortPartners (const partner &p1, const partner &p2)
 

Protected Attributes

std::vector< partnerthePartners
 

Detailed Description

Definition at line 91 of file G4NucleiModel.hh.

Member Typedef Documentation

◆ modelLists

typedef std::pair<std::vector<G4CascadParticle>, std::vector<G4InuclElementaryParticle> > G4NucleiModel::modelLists

Definition at line 161 of file G4NucleiModel.hh.

◆ partner

Definition at line 203 of file G4NucleiModel.hh.

Constructor & Destructor Documentation

◆ G4NucleiModel() [1/3]

G4NucleiModel::G4NucleiModel ( )

Definition at line 233 of file G4NucleiModel.cc.

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),
238 crossSectionUnits(G4CascadeParameters::xsecScale()),
240 skinDepth(0.611207*radiusUnits),
241 radiusScale((G4CascadeParameters::useTwoParam()?1.16:1.2)*radiusUnits),
242 radiusScale2((G4CascadeParameters::useTwoParam()?-1.3456:0.)*radiusUnits),
243 radiusForSmall(G4CascadeParameters::radiusSmall()),
244 radScaleAlpha(G4CascadeParameters::radiusAlpha()),
245 fermiMomentum(G4CascadeParameters::fermiScale()),
247 gammaQDscale(G4CascadeParameters::gammaQDScale()),
248 potentialThickness(1.0),
249 neutronEP(neutron), protonEP(proton) {}
static G4double xsecScale()
static G4double radiusScale()
static G4bool useTwoParam()
static G4double gammaQDScale()
static G4double radiusAlpha()
static G4double radiusSmall()
static G4double fermiScale()
static G4double radiusTrailing()

◆ G4NucleiModel() [2/3]

G4NucleiModel::G4NucleiModel ( G4int a,
G4int z )

Definition at line 251 of file G4NucleiModel.cc.

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),
256 crossSectionUnits(G4CascadeParameters::xsecScale()),
258 skinDepth(0.611207*radiusUnits),
259 radiusScale((G4CascadeParameters::useTwoParam()?1.16:1.2)*radiusUnits),
260 radiusScale2((G4CascadeParameters::useTwoParam()?-1.3456:0.)*radiusUnits),
261 radiusForSmall(G4CascadeParameters::radiusSmall()),
262 radScaleAlpha(G4CascadeParameters::radiusAlpha()),
263 fermiMomentum(G4CascadeParameters::fermiScale()),
265 gammaQDscale(G4CascadeParameters::gammaQDScale()),
266 potentialThickness(1.0),
267 neutronEP(neutron), protonEP(proton) {
268 generateModel(a,z);
269}
void generateModel(G4InuclNuclei *nuclei)

◆ G4NucleiModel() [3/3]

G4NucleiModel::G4NucleiModel ( G4InuclNuclei * nuclei)
explicit

Definition at line 271 of file G4NucleiModel.cc.

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),
276 crossSectionUnits(G4CascadeParameters::xsecScale()),
278 skinDepth(0.611207*radiusUnits),
279 radiusScale((G4CascadeParameters::useTwoParam()?1.16:1.2)*radiusUnits),
280 radiusScale2((G4CascadeParameters::useTwoParam()?-1.3456:0.)*radiusUnits),
281 radiusForSmall(G4CascadeParameters::radiusSmall()),
282 radScaleAlpha(G4CascadeParameters::radiusAlpha()),
283 fermiMomentum(G4CascadeParameters::fermiScale()),
285 gammaQDscale(G4CascadeParameters::gammaQDScale()),
286 potentialThickness(1.0),
287 neutronEP(neutron), protonEP(proton) {
289}

◆ ~G4NucleiModel()

G4NucleiModel::~G4NucleiModel ( )
virtual

Definition at line 291 of file G4NucleiModel.cc.

291 {
292 delete theNucleus;
293 theNucleus = 0;
294}

Member Function Documentation

◆ absorptionCrossSection()

G4double G4NucleiModel::absorptionCrossSection ( G4double e,
G4int type ) const

Definition at line 1968 of file G4NucleiModel.cc.

1968 {
1969 if (!useQuasiDeuteron(type)) {
1970 G4cerr << "absorptionCrossSection() only valid for incident pions or gammas"
1971 << G4endl;
1972 return 0.;
1973 }
1974
1975 G4double csec = 0.;
1976
1977 // Pion absorption is parametrized for low vs. medium energy
1978 // ... use for muon capture as well
1979 if (type == pionPlus || type == pionMinus || type == pionZero ||
1980 type == muonMinus) {
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);
1984 }
1985
1986 if (type == photon) {
1987 csec = gammaQDinterp.interpolate(ke, gammaQDxsec) * gammaQDscale;
1988 }
1989
1990 if (csec < 0.0) csec = 0.0;
1991
1992 if (verboseLevel > 2) {
1993 G4cout << " ekin " << ke << " abs. csec " << csec << " mb" << G4endl;
1994 }
1995
1996 return crossSectionUnits * csec;
1997}
double G4double
Definition G4Types.hh:83
G4GLOB_DLL std::ostream G4cerr
#define G4endl
Definition G4ios.hh:67
G4GLOB_DLL std::ostream G4cout
static G4bool useQuasiDeuteron(G4int ptype, G4int qdtype=0)

Referenced by inverseMeanFreePath().

◆ boundaryTransition()

void G4NucleiModel::boundaryTransition ( G4CascadParticle & cparticle)
protected

Definition at line 1118 of file G4NucleiModel.cc.

1118 {
1119 if (verboseLevel > 1) {
1120 G4cout << " >>> G4NucleiModel::boundaryTransition" << G4endl;
1121 }
1122
1123 G4int zone = cparticle.getCurrentZone();
1124
1125 if (cparticle.movingInsideNuclei() && zone == 0) {
1126 if (verboseLevel) G4cerr << " boundaryTransition-> in zone 0 " << G4endl;
1127 return;
1128 }
1129
1130 G4LorentzVector mom = cparticle.getMomentum();
1131 G4ThreeVector pos = cparticle.getPosition();
1132
1133 G4int type = cparticle.getParticle().type();
1134
1135 G4double r = pos.mag();
1136 G4double p = mom.vect().mag(); // NAT
1137 G4double pr = pos.dot(mom.vect()) / r;
1138 G4double pperp2 = p*p - pr*pr; // NAT
1139
1140 G4int next_zone = cparticle.movingInsideNuclei() ? zone - 1 : zone + 1;
1141
1142 // NOTE: dv is the height of the wall seen by the particle
1143 G4double dv = getPotential(type,next_zone) - getPotential(type,zone);
1144 if (verboseLevel > 3) {
1145 G4cout << "Potentials for type " << type << " = "
1146 << getPotential(type,zone) << " , "
1147 << getPotential(type,next_zone) << G4endl;
1148 }
1149
1150 G4double qv = dv*dv + 2.0*dv*mom.e() + pr*pr;
1151 // G4double qv = dv*dv + 2.0*dv*mom.m() + pr*pr; // more correct? NAT
1152 G4double p1r = 0.;
1153
1154 // Perpendicular contribution to pr^2 after penetrating // NAT
1155 // potential, to leading order in thickness // NAT
1156 G4double qperp = 2.0*pperp2*potentialThickness/r; // NAT
1157
1158 if (verboseLevel > 3) {
1159 G4cout << " type " << type << " zone " << zone << " next " << next_zone
1160 << " qv " << qv << " dv " << dv << G4endl;
1161 }
1162
1163 G4bool adjustpperp = false; // NAT
1164 G4double smallish = 0.001; // NAT
1165
1166// if (qv <= 0.0) { // reflection
1167 if (qv <= 0.0 && qv+qperp <=0 ) { // reflection // NAT
1168 if (verboseLevel > 3) G4cout << " reflects off boundary" << G4endl;
1169 p1r = -pr;
1170 cparticle.incrementReflectionCounter();
1171// } else { // transition
1172
1173 } else if (qv > 0.0) { // standard transition // NAT
1174 if (verboseLevel > 3) G4cout << " passes thru boundary" << G4endl;
1175 p1r = std::sqrt(qv);
1176 if (pr < 0.0) p1r = -p1r;
1177 cparticle.updateZone(next_zone);
1178 cparticle.resetReflection();
1179
1180 } else { // transition via transverse kinetic energy (allowed for thick walls) // NAT
1181 if (verboseLevel > 3) G4cout << " passes thru boundary due to angular momentum" << G4endl;
1182 p1r = smallish * pr; // don't want exactly tangent momentum
1183 adjustpperp = true;
1184
1185 cparticle.updateZone(next_zone);
1186 cparticle.resetReflection();
1187 }
1188
1189 G4double prr = (p1r - pr)/r; // change to radial momentum, divided by r
1190
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;
1195 }
1196
1197 if (adjustpperp) { // NAT
1198 G4ThreeVector old_pperp = mom.vect() - pos*(pr/r);
1199 G4double new_pperp_mag = std::sqrt(std::max(0.0, pperp2 + qv - p1r*p1r) );
1200 // new total momentum found by rescaling p_perp
1201 mom.setVect(old_pperp * new_pperp_mag/std::sqrt(pperp2));
1202 // add a small radial component to make sure that we propagate into new zone
1203 mom.setVect(mom.vect() + pos*p1r/r);
1204 } else {
1205 mom.setVect(mom.vect() + pos*prr);
1206 }
1207
1208 cparticle.updateParticleMomentum(mom);
1209}
CLHEP::HepLorentzVector G4LorentzVector
CLHEP::Hep3Vector G4ThreeVector
bool G4bool
Definition G4Types.hh:86
int G4int
Definition G4Types.hh:85
double mag() const
Hep3Vector vect() const
void setVect(const Hep3Vector &)
void updateZone(G4int izone)
const G4InuclElementaryParticle & getParticle() const
void updateParticleMomentum(const G4LorentzVector &mom)
G4bool movingInsideNuclei() const
G4LorentzVector getMomentum() const
void incrementReflectionCounter()
G4int getCurrentZone() const
const G4ThreeVector & getPosition() const
G4double getPotential(G4int ip, G4int izone) const

Referenced by generateParticleFate().

◆ choosePointAlongTraj()

void G4NucleiModel::choosePointAlongTraj ( G4CascadParticle & cparticle)
protected

Definition at line 1215 of file G4NucleiModel.cc.

1215 {
1216 if (verboseLevel > 1)
1217 G4cout << " >>> G4NucleiModel::choosePointAlongTraj" << G4endl;
1218
1219 // Get trajectory through nucleus by computing exit point of line,
1220 // assuming that current position is on surface
1221
1222 // FIXME: These need to be reusable (static) buffers
1223 G4ThreeVector pos = cparticle.getPosition();
1224 G4ThreeVector rhat = pos.unit();
1225
1226 G4ThreeVector phat = cparticle.getMomentum().vect().unit();
1227 if (cparticle.getMomentum().vect().mag() < small) phat.set(0.,0.,1.);
1228
1229 if (verboseLevel > 3)
1230 G4cout << " pos " << pos << " phat " << phat << " rhat " << rhat << G4endl;
1231
1232 G4ThreeVector posout = pos;
1233 G4double prang = rhat.angle(-phat);
1234
1235 if (prang < 1e-6) posout = -pos; // Check for radial incidence
1236 else {
1237 G4double posrot = 2.*prang - pi;
1238 posout.rotate(posrot, phat.cross(rhat));
1239 if (verboseLevel > 3) G4cout << " posrot " << posrot/deg << " deg";
1240 }
1241
1242 if (verboseLevel > 3) G4cout << " posout " << posout << G4endl;
1243
1244 // Get list of zone crossings along trajectory
1245 G4ThreeVector posmid = (pos+posout)/2.; // Midpoint of trajectory
1246 G4double r2mid = posmid.mag2();
1247 G4double lenmid = (posout-pos).mag()/2.; // Half-length of trajectory
1248
1249 G4int zoneout = number_of_zones-1;
1250 G4int zonemid = getZone(posmid.mag()); // Middle zone traversed
1251
1252 // Every zone is entered then exited, so preallocate vector
1253 G4int ncross = (number_of_zones-zonemid)*2;
1254
1255 if (verboseLevel > 3) {
1256 G4cout << " posmid " << posmid << " lenmid " << lenmid
1257 << " zoneout " << zoneout << " zonemid " << zonemid
1258 << " ncross " << ncross << G4endl;
1259 }
1260
1261 // FIXME: These need to be reusable (static) buffers
1262 std::vector<G4double> wtlen(ncross,0.); // CDF from entry point
1263 std::vector<G4double> len(ncross,0.); // Distance from entry point
1264
1265 // Work from outside in, to accumulate CDF steps properly
1266 G4int i; // Loop variable, used multiple times
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);
1270
1271 len[i] = lenmid - ds; // Distance from entry to crossing
1272 len[ncross-1-i] = lenmid + ds; // Distance to outbound crossing
1273
1274 if (verboseLevel > 3) {
1275 G4cout << " i " << i << " iz " << iz << " ds " << ds
1276 << " len " << len[i] << G4endl;
1277 }
1278 }
1279
1280 // Compute weights for each zone along trajectory and integrate
1281 for (i=1; i<ncross; i++) {
1282 G4int iz = (i<ncross/2) ? zoneout-i+1 : zoneout-ncross+i+1;
1283
1284 G4double dlen = len[i]-len[i-1]; // Distance from previous crossing
1285
1286 // Uniform probability across entire zone
1287 //*** G4double wt = dlen*(getDensity(1,iz)+getDensity(2,iz));
1288
1289 // Probability based on interaction length through zone
1290 G4double invmfp = (inverseMeanFreePath(cparticle, neutronEP, iz)
1291 + inverseMeanFreePath(cparticle, protonEP, iz));
1292
1293 // Integral of exp(-len/mfp) from start of zone to end
1294 G4double wt = (G4Exp(-len[i-1]*invmfp)-G4Exp(-len[i]*invmfp)) / invmfp;
1295
1296 wtlen[i] = wtlen[i-1] + wt;
1297
1298 if (verboseLevel > 3) {
1299 G4cout << " i " << i << " iz " << iz << " avg.mfp " << 1./invmfp
1300 << " dlen " << dlen << " wt " << wt << " wtlen " << wtlen[i]
1301 << G4endl;
1302 }
1303 }
1304
1305 // Normalize CDF to unit integral
1306 std::transform(wtlen.begin(), wtlen.end(), wtlen.begin(),
1307 std::bind(std::divides<G4double>(), std::placeholders::_1, wtlen.back()));
1308
1309 if (verboseLevel > 3) {
1310 G4cout << " weights";
1311 for (i=0; i<ncross; i++) G4cout << " " << wtlen[i];
1312 G4cout << G4endl;
1313 }
1314
1315 // Choose random point along trajectory, weighted by density
1316 G4double rand = G4UniformRand();
1317 G4long ir = std::upper_bound(wtlen.begin(),wtlen.end(),rand) - wtlen.begin();
1318
1319 G4double frac = (rand-wtlen[ir-1]) / (wtlen[ir]-wtlen[ir-1]);
1320 G4double drand = (1.-frac)*len[ir-1] + frac*len[ir];
1321
1322 if (verboseLevel > 3) {
1323 G4cout << " rand " << rand << " ir " << ir << " frac " << frac
1324 << " drand " << drand << G4endl;
1325 }
1326
1327 pos += drand * phat; // Distance from entry point along trajectory
1328
1329 // Update input particle with new location
1330 cparticle.updatePosition(pos);
1331 cparticle.updateZone(getZone(pos.mag()));
1332
1333 if (verboseLevel > 2) {
1334 G4cout << " moved particle to zone " << cparticle.getCurrentZone()
1335 << " @ " << pos << G4endl;
1336 }
1337}
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition G4Exp.hh:180
long G4long
Definition G4Types.hh:87
#define G4UniformRand()
Definition Randomize.hh:52
Hep3Vector unit() const
double mag2() const
Hep3Vector cross(const Hep3Vector &) const
double angle(const Hep3Vector &) const
void set(double x, double y, double z)
Hep3Vector & rotate(double, const Hep3Vector &)
void updatePosition(const G4ThreeVector &pos)
G4int getZone(G4double r) const
G4double inverseMeanFreePath(const G4CascadParticle &cparticle, const G4InuclElementaryParticle &target, G4int zone=-1)
const G4double pi

Referenced by initializeCascad().

◆ empty()

G4bool G4NucleiModel::empty ( ) const
inline

Definition at line 150 of file G4NucleiModel.hh.

150 {
151 return neutronNumberCurrent < 1 && protonNumberCurrent < 1;
152 }

◆ fillBindingEnergies()

void G4NucleiModel::fillBindingEnergies ( )
protected

Definition at line 393 of file G4NucleiModel.cc.

393 {
394 if (verboseLevel > 1)
395 G4cout << " >>> G4NucleiModel::fillBindingEnergies" << G4endl;
396
397 G4double dm = bindingEnergy(A,Z);
398
399 // Binding energy differences for proton and neutron loss, respectively
400 // FIXME: Why is fabs() used here instead of the signed difference?
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);
403}
G4double bindingEnergy(G4int A, G4int Z)

Referenced by generateModel().

◆ fillPotentials()

void G4NucleiModel::fillPotentials ( G4int type,
G4double tot_vol )
protected

Definition at line 482 of file G4NucleiModel.cc.

482 {
483 if (verboseLevel > 1)
484 G4cout << " >>> G4NucleiModel::fillZoneVolumes(" << type << ")" << G4endl;
485
486 if (type != proton && type != neutron) return;
487
489
490 // FIXME: This is the fabs() binding energy difference, not signed
491 const G4double dm = binding_energies[type-1];
492
493 rod.clear(); rod.reserve(number_of_zones);
494 pf.clear(); pf.reserve(number_of_zones);
495 vz.clear(); vz.reserve(number_of_zones);
496
497 G4int nNucleons = (type==proton) ? protonNumber : neutronNumber;
498 G4double dd0 = nNucleons / tot_vol / piTimes4thirds;
499
500 for (G4int i = 0; i < number_of_zones; i++) {
501 G4double rd = dd0 * v[i] / v1[i];
502 rod.push_back(rd);
503 G4double pff = fermiMomentum * G4cbrt(rd);
504 pf.push_back(pff);
505 vz.push_back(0.5 * pff * pff / mass + dm);
506 }
507
508 nucleon_densities.push_back(rod);
509 fermi_momenta.push_back(pf);
510 zone_potentials.push_back(vz);
511}
static G4double getParticleMass(G4int type)

Referenced by generateModel().

◆ fillZoneRadii()

void G4NucleiModel::fillZoneRadii ( G4double nuclearRadius)
protected

Definition at line 407 of file G4NucleiModel.cc.

407 {
408 if (verboseLevel > 1)
409 G4cout << " >>> G4NucleiModel::fillZoneRadii" << G4endl;
410
411 G4double skinRatio = nuclearRadius/skinDepth;
412 G4double skinDecay = G4Exp(-skinRatio);
413
414 if (A < 5) { // Light ions treated as simple balls
415 zone_radii.push_back(nuclearRadius);
416 ur[0] = 0.;
417 ur[1] = 1.;
418 } else if (A < 12) { // Small nuclei have Gaussian potential
419 G4double rSq = nuclearRadius * nuclearRadius;
420 G4double gaussRadius = std::sqrt(rSq * (1.0 - 1.0/A) + 6.4);
421
422 ur[0] = 0.0;
423 for (G4int i = 0; i < number_of_zones; i++) {
424 G4double y = std::sqrt(-G4Log(alfa3[i]));
425 zone_radii.push_back(gaussRadius * y);
426 ur[i+1] = y;
427 }
428 } else if (A < 100) { // Intermediate nuclei have three-zone W-S
429 ur[0] = -skinRatio;
430 for (G4int i = 0; i < number_of_zones; i++) {
431 G4double y = G4Log((1.0 + skinDecay)/alfa3[i] - 1.0);
432 zone_radii.push_back(nuclearRadius + skinDepth * y);
433 ur[i+1] = y;
434 }
435 } else { // Heavy nuclei have six-zone W-S
436 ur[0] = -skinRatio;
437 for (G4int i = 0; i < number_of_zones; i++) {
438 G4double y = G4Log((1.0 + skinDecay)/alfa6[i] - 1.0);
439 zone_radii.push_back(nuclearRadius + skinDepth * y);
440 ur[i+1] = y;
441 }
442 }
443}
G4double G4Log(G4double x)
Definition G4Log.hh:227

Referenced by generateModel().

◆ fillZoneVolumes()

G4double G4NucleiModel::fillZoneVolumes ( G4double nuclearRadius)
protected

Definition at line 447 of file G4NucleiModel.cc.

447 {
448 if (verboseLevel > 1)
449 G4cout << " >>> G4NucleiModel::fillZoneVolumes" << G4endl;
450
451 G4double tot_vol = 0.; // Return value omitting 4pi/3 for sphere!
452
453 if (A < 5) { // Light ions are treated as simple balls
454 v[0] = v1[0] = 1.;
455 tot_vol = zone_radii[0]*zone_radii[0]*zone_radii[0];
456 zone_volumes.push_back(tot_vol*piTimes4thirds); // True volume of sphere
457
458 return tot_vol;
459 }
460
461 PotentialType usePotential = (A < 12) ? Gaussian : WoodsSaxon;
462
463 for (G4int i = 0; i < number_of_zones; i++) {
464 if (usePotential == WoodsSaxon) {
465 v[i] = zoneIntegralWoodsSaxon(ur[i], ur[i+1], nuclearRadius);
466 } else {
467 v[i] = zoneIntegralGaussian(ur[i], ur[i+1], nuclearRadius);
468 }
469
470 tot_vol += v[i];
471
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];
474
475 zone_volumes.push_back(v1[i]*piTimes4thirds); // True volume of shell
476 }
477
478 return tot_vol; // Sum of zone integrals, not geometric volume
479}
G4double zoneIntegralGaussian(G4double ur1, G4double ur2, G4double nuclearRadius) const
G4double zoneIntegralWoodsSaxon(G4double ur1, G4double ur2, G4double nuclearRadius) const

Referenced by generateModel().

◆ forceFirst()

G4bool G4NucleiModel::forceFirst ( const G4CascadParticle & cparticle) const

Definition at line 1341 of file G4NucleiModel.cc.

1341 {
1342 return (isProjectile(cparticle) &&
1343 (cparticle.getParticle().isPhoton() ||
1344 cparticle.getParticle().isMuon())
1345 );
1346}
G4bool isProjectile(const G4CascadParticle &cparticle) const

Referenced by generateInteractionLength(), and initializeCascad().

◆ generateInteractionLength()

G4double G4NucleiModel::generateInteractionLength ( const G4CascadParticle & cparticle,
G4double path,
G4double invmfp ) const
protected

Definition at line 1936 of file G4NucleiModel.cc.

1937 {
1938 // Delay interactions of newly formed secondaries (minimum int. length)
1939 const G4double young_cut = std::sqrt(10.0) * 0.25;
1940 const G4double huge_num = 50.0; // Argument to exponential
1941
1942 G4double spath = large; // Buffer for return value
1943
1944 if (invmfp < small) return spath; // No interaction, avoid unnecessary work
1945
1946 G4double pw = -path * invmfp; // Ratio of path in zone to MFP
1947 if (pw < -huge_num) pw = -huge_num;
1948 pw = 1.0 - G4Exp(pw);
1949
1950 if (verboseLevel > 2)
1951 G4cout << " mfp " << 1./invmfp << " pw " << pw << G4endl;
1952
1953 // Primary particle(s) should always interact at least once
1954 if (forceFirst(cparticle) || (G4UniformRand() < pw) ) {
1955 spath = -G4Log(1.0 - pw*G4UniformRand() )/invmfp;
1956 if (cparticle.young(young_cut, spath)) spath = large;
1957
1958 if (verboseLevel > 2)
1959 G4cout << " spath " << spath << " path " << path << G4endl;
1960 }
1961
1962 return spath;
1963}
G4bool young(G4double young_path_cut, G4double cpath) const
G4bool forceFirst(const G4CascadParticle &cparticle) const

Referenced by generateInteractionPartners().

◆ generateInteractionPartners()

void G4NucleiModel::generateInteractionPartners ( G4CascadParticle & cparticle)
protected

Definition at line 697 of file G4NucleiModel.cc.

697 {
698 if (verboseLevel > 1) {
699 G4cout << " >>> G4NucleiModel::generateInteractionPartners" << G4endl;
700 }
701
702 thePartners.clear(); // Reset buffer for next cycle
703
704 G4int ptype = cparticle.getParticle().type();
705 G4int zone = cparticle.getCurrentZone();
706
707 G4double r_in; // Destination radius if inbound
708 G4double r_out; // Destination radius if outbound
709
710 if (zone == number_of_zones) {
711 r_in = nuclei_radius;
712 r_out = 0.0;
713 } else if (zone == 0) { // particle is outside core
714 r_in = 0.0;
715 r_out = zone_radii[0];
716 } else {
717 r_in = zone_radii[zone - 1];
718 r_out = zone_radii[zone];
719 }
720
721 G4double path = cparticle.getPathToTheNextZone(r_in, r_out);
722
723 if (verboseLevel > 2) {
724 if (isProjectile(cparticle)) G4cout << " incident particle: ";
725 G4cout << " r_in " << r_in << " r_out " << r_out << " path " << path
726 << G4endl;
727 }
728
729 if (path < -small) { // something wrong
730 if (verboseLevel)
731 G4cerr << " generateInteractionPartners-> negative path length" << G4endl;
732 return;
733 }
734
735 if (std::fabs(path) < small) { // Not moving, or just at boundary
736 if (cparticle.getMomentum().vect().mag() > small) {
737 if (verboseLevel > 3)
738 G4cout << " generateInteractionPartners-> zero path" << G4endl;
739
740 thePartners.push_back(partner()); // Dummy list terminator with zero path
741 return;
742 }
743
744 if (zone >= number_of_zones) // Place captured-at-rest in nucleus
745 zone = number_of_zones-1;
746 }
747
748 G4double invmfp = 0.; // Buffers for interaction probability
749 G4double spath = 0.;
750 for (G4int ip = 1; ip < 3; ip++) {
751 // Only process nucleons which remain active in target
752 if (ip==proton && protonNumberCurrent < 1) continue;
753 if (ip==neutron && neutronNumberCurrent < 1) continue;
754 if (ip==neutron && ptype==muonMinus) continue; // mu-/n forbidden
755
756 // All nucleons are assumed to be at rest when colliding
757 G4InuclElementaryParticle particle = generateNucleon(ip, zone);
758 invmfp = inverseMeanFreePath(cparticle, particle);
759 spath = generateInteractionLength(cparticle, path, invmfp);
760
761 if (path<small || spath < path) {
762 if (verboseLevel > 3) {
763 G4cout << " adding partner[" << thePartners.size() << "]: "
764 << particle << G4endl;
765 }
766 thePartners.push_back(partner(particle, spath));
767 }
768 } // for (G4int ip...
769
770 if (verboseLevel > 2) {
771 G4cout << " after nucleons " << thePartners.size() << " path " << path << G4endl;
772 }
773
774 // Absorption possible for pions or photons interacting with dibaryons
775 if (useQuasiDeuteron(cparticle.getParticle().type())) {
776 if (verboseLevel > 2) {
777 G4cout << " trying quasi-deuterons with bullet: "
778 << cparticle.getParticle() << G4endl;
779 }
780
781 // Initialize buffers for quasi-deuteron results
782 qdeutrons.clear();
783 acsecs.clear();
784
785 G4double tot_invmfp = 0.0; // Total inv. mean-free-path for all QDs
786
787 // Proton-proton state interacts with pi-, mu- or neutrals
788 if (protonNumberCurrent >= 2 && ptype != pip) {
789 G4InuclElementaryParticle ppd = generateQuasiDeuteron(pro, pro, zone);
790 if (verboseLevel > 2)
791 G4cout << " ptype=" << ptype << " using pp target\n" << ppd << G4endl;
792
793 invmfp = inverseMeanFreePath(cparticle, ppd);
794 tot_invmfp += invmfp;
795 acsecs.push_back(invmfp);
796 qdeutrons.push_back(ppd);
797 }
798
799 // Proton-neutron state interacts with any pion type or photon
800 if (protonNumberCurrent >= 1 && neutronNumberCurrent >= 1) {
801 G4InuclElementaryParticle npd = generateQuasiDeuteron(pro, neu, zone);
802 if (verboseLevel > 2)
803 G4cout << " ptype=" << ptype << " using np target\n" << npd << G4endl;
804
805 invmfp = inverseMeanFreePath(cparticle, npd);
806 tot_invmfp += invmfp;
807 acsecs.push_back(invmfp);
808 qdeutrons.push_back(npd);
809 }
810
811 // Neutron-neutron state interacts with pi+ or neutrals
812 if (neutronNumberCurrent >= 2 && ptype != pim && ptype != mum) {
813 G4InuclElementaryParticle nnd = generateQuasiDeuteron(neu, neu, zone);
814 if (verboseLevel > 2)
815 G4cout << " ptype=" << ptype << " using nn target\n" << nnd << G4endl;
816
817 invmfp = inverseMeanFreePath(cparticle, nnd);
818 tot_invmfp += invmfp;
819 acsecs.push_back(invmfp);
820 qdeutrons.push_back(nnd);
821 }
822
823 // Select quasideuteron interaction from non-zero cross-section choices
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];
828 }
829 G4cout << G4endl;
830 }
831
832 if (tot_invmfp > small) { // Must have absorption cross-section
833 G4double apath = generateInteractionLength(cparticle, path, tot_invmfp);
834
835 if (path<small || apath < path) { // choose the qdeutron
836 G4double sl = G4UniformRand()*tot_invmfp;
837 G4double as = 0.0;
838
839 for (std::size_t i = 0; i < qdeutrons.size(); i++) {
840 as += acsecs[i];
841 if (sl < as) {
842 if (verboseLevel > 2)
843 G4cout << " deut type " << qdeutrons[i] << G4endl;
844
845 thePartners.push_back(partner(qdeutrons[i], apath));
846 break;
847 }
848 } // for (qdeutrons...
849 } // if (apath < path)
850 } // if (tot_invmfp > small)
851 } // if (useQuasiDeuteron) [pion, muon or photon]
852
853 if (verboseLevel > 2) {
854 G4cout << " after deuterons " << thePartners.size() << " partners"
855 << G4endl;
856 }
857
858 if (thePartners.size() > 1) { // Sort list by path length
859 std::sort(thePartners.begin(), thePartners.end(), sortPartners);
860 }
861
862 G4InuclElementaryParticle particle; // Total path at end of list
863 thePartners.push_back(partner(particle, path));
864}
G4double getPathToTheNextZone(G4double rz_in, G4double rz_out)
G4double generateInteractionLength(const G4CascadParticle &cparticle, G4double path, G4double invmfp) const
std::pair< G4InuclElementaryParticle, G4double > partner
G4InuclElementaryParticle generateNucleon(G4int type, G4int zone) const
G4InuclElementaryParticle generateQuasiDeuteron(G4int type1, G4int type2, G4int zone) const
std::vector< partner > thePartners
static G4bool sortPartners(const partner &p1, const partner &p2)

Referenced by generateParticleFate().

◆ generateModel() [1/2]

void G4NucleiModel::generateModel ( G4int a,
G4int z )

Definition at line 316 of file G4NucleiModel.cc.

316 {
317 if (verboseLevel) {
318 G4cout << " >>> G4NucleiModel::generateModel A " << a << " Z " << z
319 << G4endl;
320 }
321
322 // If model already built, just return; otherwise initialize everything
323 if (a == A && z == Z) {
324 if (verboseLevel > 1) G4cout << " model already generated" << z << G4endl;
325 reset();
326 return;
327 }
328
329 A = a;
330 Z = z;
331 delete theNucleus;
332 theNucleus = new G4InuclNuclei(A,Z); // For conservation checking
333
334 neutronNumber = A - Z;
335 protonNumber = Z;
336 reset();
337
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;
348 }
349
350 G4double nuclearRadius; // Nuclear radius computed from A
351 if (A>4) nuclearRadius = radiusScale*G4cbrt(A) + radiusScale2/G4cbrt(A);
352 else nuclearRadius = radiusForSmall * (A==4 ? radScaleAlpha : 1.);
353
354 // This will be used to pre-allocate lots of arrays below
355 number_of_zones = (A < 5) ? 1 : (A < 100) ? 3 : 6;
356
357 // Clear all parameters arrays for reloading
358 binding_energies.clear();
359 nucleon_densities.clear();
360 zone_potentials.clear();
361 fermi_momenta.clear();
362 zone_radii.clear();
363 zone_volumes.clear();
364
366 fillZoneRadii(nuclearRadius);
367
368 G4double tot_vol = fillZoneVolumes(nuclearRadius); // Woods-Saxon integral
369
370 fillPotentials(proton, tot_vol); // Protons
371 fillPotentials(neutron, tot_vol); // Neutrons
372
373 // Additional flat zone potentials for other hadrons
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);
377
378 zone_potentials.push_back(std::move(vp));
379 zone_potentials.push_back(std::move(kp));
380 zone_potentials.push_back(std::move(hp));
381
383
384 nuclei_radius = zone_radii.back();
385 nuclei_volume = std::accumulate(zone_volumes.begin(),zone_volumes.end(),0.);
386
387 if (verboseLevel > 3) printModel();
388}
void setDinucleonDensityScale()
void printModel() const
void fillBindingEnergies()
G4double fillZoneVolumes(G4double nuclearRadius)
void reset(G4int nHitNeutrons=0, G4int nHitProtons=0, const std::vector< G4ThreeVector > *hitPoints=0)
void fillZoneRadii(G4double nuclearRadius)
void fillPotentials(G4int type, G4double tot_vol)

◆ generateModel() [2/2]

void G4NucleiModel::generateModel ( G4InuclNuclei * nuclei)

Definition at line 312 of file G4NucleiModel.cc.

312 {
313 generateModel(nuclei->getA(), nuclei->getZ());
314}

Referenced by G4NucleiModel(), G4NucleiModel(), and generateModel().

◆ generateNucleon()

G4InuclElementaryParticle G4NucleiModel::generateNucleon ( G4int type,
G4int zone ) const

Definition at line 660 of file G4NucleiModel.cc.

660 {
661 if (verboseLevel > 1) {
662 G4cout << " >>> G4NucleiModel::generateNucleon" << G4endl;
663 }
664
666 return G4InuclElementaryParticle(mom, type);
667}
G4LorentzVector generateNucleonMomentum(G4int type, G4int zone) const

Referenced by generateInteractionPartners().

◆ generateNucleonMomentum()

G4LorentzVector G4NucleiModel::generateNucleonMomentum ( G4int type,
G4int zone ) const

Definition at line 651 of file G4NucleiModel.cc.

651 {
652 G4double pmod = getFermiMomentum(type, zone) * G4cbrt(G4UniformRand() );
654
655 return generateWithRandomAngles(pmod, mass);
656}
G4double getFermiMomentum(G4int ip, G4int izone) const
G4LorentzVector generateWithRandomAngles(G4double p, G4double mass=0.)

Referenced by generateNucleon(), and generateQuasiDeuteron().

◆ generateParticleFate()

void G4NucleiModel::generateParticleFate ( G4CascadParticle & cparticle,
G4ElementaryParticleCollider * theEPCollider,
std::vector< G4CascadParticle > & cascade )

Definition at line 867 of file G4NucleiModel.cc.

870 {
871 if (verboseLevel > 1)
872 G4cout << " >>> G4NucleiModel::generateParticleFate" << G4endl;
873
874 if (verboseLevel > 2) G4cout << " cparticle: " << cparticle << G4endl;
875
876 // Create four-vector checking
877#ifdef G4CASCADE_CHECK_ECONS
878 G4CascadeCheckBalance balance(0.005, 0.01, "G4NucleiModel"); // Second arg is in GeV
879 balance.setVerboseLevel(verboseLevel);
880#endif
881
882 outgoing_cparticles.clear(); // Clear return buffer for this event
883 generateInteractionPartners(cparticle); // Fills "thePartners" data
884
885 if (thePartners.empty()) { // smth. is wrong -> needs special treatment
886 if (verboseLevel)
887 G4cerr << " generateParticleFate-> got empty interaction-partners list "
888 << G4endl;
889 return;
890 }
891
892 std::size_t npart = thePartners.size(); // Last item is a total-path placeholder
893
894 if (npart == 1) { // cparticle is on the next zone entry
895 if (verboseLevel > 1)
896 G4cout << " no interactions; moving to next zone" << G4endl;
897
898 cparticle.propagateAlongThePath(thePartners[0].second);
899 cparticle.incrementCurrentPath(thePartners[0].second);
900 boundaryTransition(cparticle);
901 outgoing_cparticles.push_back(cparticle);
902
903 if (verboseLevel > 2) G4cout << " next zone \n" << cparticle << G4endl;
904
905 //A.R. 19-Jun-2013: Fixed rare cases of non-reproducibility.
906 current_nucl1 = 0;
907 current_nucl2 = 0;
908
909 return;
910 } // if (npart == 1)
911
912 if (verboseLevel > 1)
913 G4cout << " processing " << npart-1 << " possible interactions" << G4endl;
914
915 G4ThreeVector old_position = cparticle.getPosition();
916 G4InuclElementaryParticle& bullet = cparticle.getParticle();
917 G4bool no_interaction = true;
918 G4int zone = cparticle.getCurrentZone();
919
920 for (std::size_t i=0; i<npart-1; ++i) { // Last item is a total-path placeholder
921 if (i > 0) cparticle.updatePosition(old_position);
922
923 G4InuclElementaryParticle& target = thePartners[i].first;
924
925 if (verboseLevel > 3) {
926 if (target.quasi_deutron()) G4cout << " try absorption: ";
927 G4cout << " target " << target.type() << " bullet " << bullet.type()
928 << G4endl;
929 }
930
931 EPCoutput.reset();
932 // Pass current (A,Z) configuration for possible recoils
933 G4int massNumberCurrent = protonNumberCurrent+neutronNumberCurrent;
934 theEPCollider->setNucleusState(massNumberCurrent, protonNumberCurrent);
935 theEPCollider->collide(&bullet, &target, EPCoutput);
936
937 // If collision failed, exit loop over partners
938 if (EPCoutput.numberOfOutgoingParticles() == 0) break;
939
940 if (verboseLevel > 2) {
941 EPCoutput.printCollisionOutput();
942#ifdef G4CASCADE_CHECK_ECONS
943 balance.collide(&bullet, &target, EPCoutput);
944 balance.okay(); // Do checks, but ignore result
945#endif
946 }
947
948 // Get list of outgoing particles for evaluation
949 std::vector<G4InuclElementaryParticle>& outgoing_particles =
950 EPCoutput.getOutgoingParticles();
951
952 if (!passFermi(outgoing_particles, zone)) continue; // Interaction fails
953
954 // Trailing effect: reject interaction at previously hit nucleon
955 cparticle.propagateAlongThePath(thePartners[i].second);
956 const G4ThreeVector& new_position = cparticle.getPosition();
957
958 if (!passTrailing(new_position)) continue;
959 collisionPts.push_back(new_position);
960
961 // Sort particles according to beta (fastest first)
962 std::sort(outgoing_particles.begin(), outgoing_particles.end(),
963 G4ParticleLargerBeta() );
964
965 if (verboseLevel > 2)
966 G4cout << " adding " << outgoing_particles.size()
967 << " output particles" << G4endl;
968
969 // NOTE: Embedded temporary is optimized away (no copying gets done)
970 G4int nextGen = cparticle.getGeneration()+1;
971 for (std::size_t ip = 0; ip < outgoing_particles.size(); ++ip) {
972 outgoing_cparticles.push_back(G4CascadParticle(outgoing_particles[ip],
973 new_position, zone,
974 0.0, nextGen));
975 }
976
977 no_interaction = false;
978 current_nucl1 = 0;
979 current_nucl2 = 0;
980
981#ifdef G4CASCADE_DEBUG_CHARGE
982 {
983 G4double out_charge = 0.0;
984
985 for (G4int ip = 0; ip < G4int(outgoing_particles.size()); ip++)
986 out_charge += outgoing_particles[ip].getCharge();
987
988 G4cout << " multiplicity " << outgoing_particles.size()
989 << " bul type " << bullet.type()
990 << " targ type " << target.type()
991 << "\n initial charge "
992 << bullet.getCharge() + target.getCharge()
993 << " out charge " << out_charge << G4endl;
994 }
995#endif
996
997 if (verboseLevel > 2)
998 G4cout << " partner type " << target.type() << G4endl;
999
1000 if (target.nucleon()) {
1001 current_nucl1 = target.type();
1002 } else {
1003 if (verboseLevel > 2) G4cout << " good absorption " << G4endl;
1004 current_nucl1 = (target.type() - 100) / 10;
1005 current_nucl2 = target.type() - 100 - 10 * current_nucl1;
1006 }
1007
1008 if (current_nucl1 == 1) {
1009 if (verboseLevel > 3) G4cout << " decrement proton count" << G4endl;
1010 protonNumberCurrent--;
1011 } else {
1012 if (verboseLevel > 3) G4cout << " decrement neutron count" << G4endl;
1013 neutronNumberCurrent--;
1014 }
1015
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--;
1022 }
1023
1024 break;
1025 } // loop over partners
1026
1027 if (no_interaction) { // still no interactions
1028 if (verboseLevel > 1) G4cout << " no interaction " << G4endl;
1029
1030 // For conservation checking (below), get particle before updating
1031 static G4ThreadLocal G4InuclElementaryParticle *prescatCP_G4MT_TLS_ = 0;
1032 if (!prescatCP_G4MT_TLS_) {
1033 prescatCP_G4MT_TLS_ = new G4InuclElementaryParticle;
1034 G4AutoDelete::Register(prescatCP_G4MT_TLS_);
1035 }
1036 G4InuclElementaryParticle &prescatCP = *prescatCP_G4MT_TLS_; // Avoid memory churn
1037 prescatCP = cparticle.getParticle();
1038
1039 // Last "partner" is just a total-path placeholder
1040 cparticle.updatePosition(old_position);
1041 cparticle.propagateAlongThePath(thePartners[npart-1].second);
1042 cparticle.incrementCurrentPath(thePartners[npart-1].second);
1043 boundaryTransition(cparticle);
1044 outgoing_cparticles.push_back(cparticle);
1045
1046 // Check conservation for simple scattering (ignore target nucleus!)
1047#ifdef G4CASCADE_CHECK_ECONS
1048 if (verboseLevel > 2) {
1049 balance.collide(&prescatCP, 0, outgoing_cparticles);
1050 balance.okay(); // Report violations, but don't act on them
1051 }
1052#endif
1053 } // if (no_interaction)
1054
1055 return;
1056}
G4int getGeneration() const
void incrementCurrentPath(G4double npath)
void propagateAlongThePath(G4double path)
void collide(G4InuclParticle *bullet, G4InuclParticle *target, G4CollisionOutput &output)
G4double getCharge() const
void boundaryTransition(G4CascadParticle &cparticle)
G4bool passTrailing(const G4ThreeVector &hit_position)
G4bool passFermi(const std::vector< G4InuclElementaryParticle > &particles, G4int zone)
void generateInteractionPartners(G4CascadParticle &cparticle)
void Register(T *inst)
#define G4ThreadLocal
Definition tls.hh:77

◆ generateQuasiDeuteron()

G4InuclElementaryParticle G4NucleiModel::generateQuasiDeuteron ( G4int type1,
G4int type2,
G4int zone ) const
protected

Definition at line 671 of file G4NucleiModel.cc.

672 {
673 if (verboseLevel > 1) {
674 G4cout << " >>> G4NucleiModel::generateQuasiDeuteron" << G4endl;
675 }
676
677 // Quasideuteron consists of an unbound but associated nucleon pair
678
679 // FIXME: Why generate two separate nucleon momenta (randomly!) and
680 // add them, instead of just throwing a net momentum for the
681 // dinulceon state? And why do I have to capture the two
682 // return values into local variables?
683 G4LorentzVector mom1 = generateNucleonMomentum(type1, zone);
684 G4LorentzVector mom2 = generateNucleonMomentum(type2, zone);
685 G4LorentzVector dmom = mom1+mom2;
686
687 G4int dtype = 0;
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;
691
692 return G4InuclElementaryParticle(dmom, dtype);
693}

Referenced by generateInteractionPartners().

◆ getCurrentDensity()

G4double G4NucleiModel::getCurrentDensity ( G4int ip,
G4int izone ) const
protected

Definition at line 1440 of file G4NucleiModel.cc.

1440 {
1441// const G4double pn_spec = 1.0; // Scale factor for pn vs. pp/nn
1442 const G4double combinatoric_factor = 0.5;
1443
1444 G4double dens = 0.;
1445
1446 if (ip < 100) dens = getDensity(ip,izone);
1447 else { // For dibaryons, remove extra 1/volume term in density product
1448 switch (ip) {
1449 case diproton:
1450 dens = getDensity(proton,izone) * getDensity(proton,izone)
1451 * dinucleonDensityScale * combinatoric_factor;
1452 break;
1453 case unboundPN:
1454 dens = getDensity(proton,izone) * getDensity(neutron,izone)
1455 * dinucleonDensityScale;
1456 break;
1457 case dineutron:
1458 dens = getDensity(neutron,izone) * getDensity(neutron,izone)
1459 * dinucleonDensityScale * combinatoric_factor;
1460 break;
1461 default: dens = 0.;
1462 }
1463 dens *= getVolume(izone);
1464 }
1465
1466 return getRatio(ip) * dens;
1467}
G4double getRatio(G4int ip) const
G4double getDensity(G4int ip, G4int izone) const
G4double getVolume(G4int izone) const

Referenced by inverseMeanFreePath().

◆ getDensity()

G4double G4NucleiModel::getDensity ( G4int ip,
G4int izone ) const
inline

Definition at line 110 of file G4NucleiModel.hh.

110 {
111 return nucleon_densities[ip - 1][izone];
112 }

Referenced by getCurrentDensity(), printModel(), and setDinucleonDensityScale().

◆ getFermiKinetic()

G4double G4NucleiModel::getFermiKinetic ( G4int ip,
G4int izone ) const

Definition at line 637 of file G4NucleiModel.cc.

637 {
638 G4double ekin = 0.0;
639
640 if (ip < 3 && izone < number_of_zones) { // ip for proton/neutron only
641 G4double pfermi = fermi_momenta[ip - 1][izone];
643
644 ekin = std::sqrt(pfermi*pfermi + mass*mass) - mass;
645 }
646 return ekin;
647}

Referenced by worthToPropagate().

◆ getFermiMomentum()

G4double G4NucleiModel::getFermiMomentum ( G4int ip,
G4int izone ) const
inline

Definition at line 114 of file G4NucleiModel.hh.

114 {
115 return fermi_momenta[ip - 1][izone];
116 }

Referenced by generateNucleonMomentum(), and printModel().

◆ getNumberOfNeutrons()

G4int G4NucleiModel::getNumberOfNeutrons ( ) const
inline

Definition at line 147 of file G4NucleiModel.hh.

147{ return neutronNumberCurrent; }

◆ getNumberOfProtons()

G4int G4NucleiModel::getNumberOfProtons ( ) const
inline

Definition at line 148 of file G4NucleiModel.hh.

148{ return protonNumberCurrent; }

◆ getNumberOfZones()

G4int G4NucleiModel::getNumberOfZones ( ) const
inline

Definition at line 141 of file G4NucleiModel.hh.

141{ return number_of_zones; }

◆ getPotential()

G4double G4NucleiModel::getPotential ( G4int ip,
G4int izone ) const
inline

Definition at line 120 of file G4NucleiModel.hh.

120 {
121 if (ip == 9 || ip < 0) return 0.0; // Photons and leptons
122 G4int ip0 = ip < 3 ? ip - 1 : 2;
123 if (ip > 10 && ip < 18) ip0 = 3;
124 if (ip > 20) ip0 = 4;
125 return izone < number_of_zones ? zone_potentials[ip0][izone] : 0.0;
126 }

Referenced by boundaryTransition(), and printModel().

◆ getRadius() [1/2]

G4double G4NucleiModel::getRadius ( ) const
inline

Definition at line 131 of file G4NucleiModel.hh.

131{ return nuclei_radius; }

◆ getRadius() [2/2]

G4double G4NucleiModel::getRadius ( G4int izone) const
inline

Definition at line 132 of file G4NucleiModel.hh.

132 {
133 return ( (izone<0) ? 0.
134 : (izone<number_of_zones) ? zone_radii[izone] : nuclei_radius);
135 }

◆ getRadiusUnits()

G4double G4NucleiModel::getRadiusUnits ( ) const
inline

Definition at line 129 of file G4NucleiModel.hh.

129{ return radiusUnits*CLHEP::fermi; }

◆ getRatio()

G4double G4NucleiModel::getRatio ( G4int ip) const
protected

Definition at line 1383 of file G4NucleiModel.cc.

1383 {
1384 if (verboseLevel > 4) {
1385 G4cout << " >>> G4NucleiModel::getRatio " << ip << G4endl;
1386 }
1387
1388 switch (ip) {
1389 case proton: return G4double(protonNumberCurrent)/G4double(protonNumber);
1390 case neutron: return G4double(neutronNumberCurrent)/G4double(neutronNumber);
1391 case diproton: return getRatio(proton)*getRatio(proton);
1392 case unboundPN: return getRatio(proton)*getRatio(neutron);
1393 case dineutron: return getRatio(neutron)*getRatio(neutron);
1394 default: return 0.;
1395 }
1396
1397 return 0.;
1398}

Referenced by getCurrentDensity(), and getRatio().

◆ getTypesOfNucleonsInvolved()

std::pair< G4int, G4int > G4NucleiModel::getTypesOfNucleonsInvolved ( ) const
inline

Definition at line 167 of file G4NucleiModel.hh.

167 {
168 return std::pair<G4int, G4int>(current_nucl1, current_nucl2);
169 }

◆ getVolume()

G4double G4NucleiModel::getVolume ( G4int izone) const
inline

Definition at line 136 of file G4NucleiModel.hh.

136 {
137 return ( (izone<0) ? 0.
138 : (izone<number_of_zones) ? zone_volumes[izone] : nuclei_volume);
139 }

Referenced by getCurrentDensity(), and setDinucleonDensityScale().

◆ getZone()

G4int G4NucleiModel::getZone ( G4double r) const
inline

Definition at line 142 of file G4NucleiModel.hh.

142 {
143 for (G4int iz=0; iz<number_of_zones; iz++) if (r<zone_radii[iz]) return iz;
144 return number_of_zones;
145 }

Referenced by choosePointAlongTraj().

◆ initializeCascad() [1/2]

G4CascadParticle G4NucleiModel::initializeCascad ( G4InuclElementaryParticle * particle)

Definition at line 1471 of file G4NucleiModel.cc.

1471 {
1472 if (verboseLevel > 1) {
1473 G4cout << " >>> G4NucleiModel::initializeCascad(particle)" << G4endl;
1474 }
1475
1476 // FIXME: Previous version generated random sin(theta), then used -cos(theta)
1477 // Using generateWithRandomAngles changes result!
1478 // G4ThreeVector pos = generateWithRandomAngles(nuclei_radius).vect();
1479 G4double costh = std::sqrt(1.0 - G4UniformRand() );
1480 G4ThreeVector pos = generateWithFixedTheta(-costh, nuclei_radius);
1481
1482 // Start particle outside nucleus, unless capture-at-rest
1483 G4int zone = number_of_zones;
1484 if (particle->getKineticEnergy() < small) zone--;
1485
1486 G4CascadParticle cpart(*particle, pos, zone, large, 0);
1487
1488 // SPECIAL CASE: Inbound photons are emplanted along through-path
1489 if (forceFirst(cpart)) choosePointAlongTraj(cpart);
1490
1491 if (verboseLevel > 2) G4cout << cpart << G4endl;
1492
1493 return cpart;
1494}
G4double getKineticEnergy() const
void choosePointAlongTraj(G4CascadParticle &cparticle)
G4LorentzVector generateWithFixedTheta(G4double ct, G4double p, G4double mass=0.)

◆ initializeCascad() [2/2]

void G4NucleiModel::initializeCascad ( G4InuclNuclei * bullet,
G4InuclNuclei * target,
modelLists & output )

Definition at line 1496 of file G4NucleiModel.cc.

1498 {
1499 if (verboseLevel) {
1500 G4cout << " >>> G4NucleiModel::initializeCascad(bullet,target,output)"
1501 << G4endl;
1502 }
1503
1504 const G4double max_a_for_cascad = 5.0;
1505 const G4double ekin_cut = 2.0;
1506 const G4double small_ekin = 1.0e-6;
1507 const G4double r_large2for3 = 62.0;
1508 const G4double r0forAeq3 = 3.92;
1509 const G4double s3max = 6.5;
1510 const G4double r_large2for4 = 69.14;
1511 const G4double r0forAeq4 = 4.16;
1512 const G4double s4max = 7.0;
1513 const G4int itry_max = 100;
1514
1515 // Convenient references to input buffer contents
1516 std::vector<G4CascadParticle>& casparticles = output.first;
1517 std::vector<G4InuclElementaryParticle>& particles = output.second;
1518
1519 casparticles.clear(); // Reset input buffer to fill this event
1520 particles.clear();
1521
1522 // first decide whether it will be cascad or compound final nuclei
1523 G4int ab = bullet->getA();
1524 G4int zb = bullet->getZ();
1525 G4int at = target->getA();
1526 G4int zt = target->getZ();
1527
1528 G4double massb = bullet->getMass(); // For creating LorentzVectors below
1529
1530 if (ab < max_a_for_cascad) {
1531
1532 G4double benb = bindingEnergy(ab,zb)/GeV / G4double(ab);
1533 G4double bent = bindingEnergy(at,zt)/GeV / G4double(at);
1534 G4double ben = benb < bent ? bent : benb;
1535
1536 if (bullet->getKineticEnergy()/ab > ekin_cut*ben) {
1537 G4int itryg = 0;
1538
1539 /* Loop checking 08.06.2015 MHK */
1540 while (casparticles.size() == 0 && itryg < itry_max) {
1541 itryg++;
1542 particles.clear();
1543
1544 // nucleons coordinates and momenta in nuclei rest frame
1545 coordinates.clear();
1546 momentums.clear();
1547
1548 if (ab < 3) { // deuteron, simplest case
1549 G4double r = 2.214 - 3.4208 * G4Log(1.0 - 0.981*G4UniformRand() );
1551 coordinates.push_back(coord1);
1552 coordinates.push_back(-coord1);
1553
1554 G4double p = 0.0;
1555 G4bool bad = true;
1556 G4int itry = 0;
1557
1558 while (bad && itry < itry_max) { /* Loop checking 08.06.2015 MHK */
1559 itry++;
1560 p = 456.0*G4UniformRand();
1561
1562 if (p*p / (p*p + 2079.36) / (p*p + 2079.36) > 1.2023e-4 *G4UniformRand()
1563 && p*r > 312.0) bad = false;
1564 }
1565
1566 if (itry == itry_max)
1567 if (verboseLevel > 2){
1568 G4cout << " deutron bullet generation-> itry = " << itry_max << G4endl;
1569 }
1570
1571 p = 0.0005 * p;
1572
1573 if (verboseLevel > 2){
1574 G4cout << " p nuc " << p << G4endl;
1575 }
1576
1578
1579 momentums.push_back(mom);
1580 mom.setVect(-mom.vect());
1581 momentums.push_back(-mom);
1582 } else {
1583 G4ThreeVector coord1;
1584
1585 G4bool badco = true;
1586
1587 G4int itry = 0;
1588
1589 if (ab == 3) {
1590 while (badco && itry < itry_max) {/* Loop checking 08.06.2015 MHK */
1591 if (itry > 0) coordinates.clear();
1592 itry++;
1593 G4int i(0);
1594
1595 for (i = 0; i < 2; i++) {
1596 G4int itry1 = 0;
1597 G4double ss, u, rho;
1598 G4double fmax = G4Exp(-0.5) / std::sqrt(0.5);
1599
1600 while (itry1 < itry_max) { /* Loop checking 08.06.2015 MHK */
1601 itry1++;
1602 ss = -G4Log(G4UniformRand() );
1603 u = fmax*G4UniformRand();
1604 rho = std::sqrt(ss) * G4Exp(-ss);
1605
1606 if (rho > u && ss < s3max) {
1607 ss = r0forAeq3 * std::sqrt(ss);
1608 coord1 = generateWithRandomAngles(ss).vect();
1609 coordinates.push_back(coord1);
1610
1611 if (verboseLevel > 2){
1612 G4cout << " i " << i << " r " << coord1.mag() << G4endl;
1613 }
1614 break;
1615 }
1616 }
1617
1618 if (itry1 == itry_max) { // bad case
1619 coord1.set(10000.,10000.,10000.);
1620 coordinates.push_back(coord1);
1621 break;
1622 }
1623 }
1624
1625 coord1 = -coordinates[0] - coordinates[1];
1626 if (verboseLevel > 2) {
1627 G4cout << " 3 r " << coord1.mag() << G4endl;
1628 }
1629
1630 coordinates.push_back(coord1);
1631
1632 G4bool large_dist = false;
1633
1634 for (i = 0; i < 2; i++) {
1635 for (G4int j = i+1; j < 3; j++) {
1636 G4double r2 = (coordinates[i]-coordinates[j]).mag2();
1637
1638 if (verboseLevel > 2) {
1639 G4cout << " i " << i << " j " << j << " r2 " << r2 << G4endl;
1640 }
1641
1642 if (r2 > r_large2for3) {
1643 large_dist = true;
1644
1645 break;
1646 }
1647 }
1648
1649 if (large_dist) break;
1650 }
1651
1652 if(!large_dist) badco = false;
1653
1654 }
1655
1656 } else { // a >= 4
1657 G4double b = 3./(ab - 2.0);
1658 G4double b1 = 1.0 - b / 2.0;
1659 G4double u = b1 + std::sqrt(b1 * b1 + b);
1660 G4double fmax = (1.0 + u/b) * u * G4Exp(-u);
1661
1662 while (badco && itry < itry_max) {/* Loop checking 08.06.2015 MHK */
1663
1664 if (itry > 0) coordinates.clear();
1665 itry++;
1666 G4int i(0);
1667
1668 for (i = 0; i < ab-1; i++) {
1669 G4int itry1 = 0;
1670 G4double ss;
1671
1672 while (itry1 < itry_max) { /* Loop checking 08.06.2015 MHK */
1673 itry1++;
1674 ss = -G4Log(G4UniformRand() );
1675 u = fmax*G4UniformRand();
1676
1677 if (std::sqrt(ss) * G4Exp(-ss) * (1.0 + ss/b) > u
1678 && ss < s4max) {
1679 ss = r0forAeq4 * std::sqrt(ss);
1680 coord1 = generateWithRandomAngles(ss).vect();
1681 coordinates.push_back(coord1);
1682
1683 if (verboseLevel > 2) {
1684 G4cout << " i " << i << " r " << coord1.mag() << G4endl;
1685 }
1686
1687 break;
1688 }
1689 }
1690
1691 if (itry1 == itry_max) { // bad case
1692 coord1.set(10000.,10000.,10000.);
1693 coordinates.push_back(coord1);
1694 break;
1695 }
1696 }
1697
1698 coord1 *= 0.0; // Cheap way to reset
1699 for(G4int j = 0; j < ab -1; j++) coord1 -= coordinates[j];
1700
1701 coordinates.push_back(coord1);
1702
1703 if (verboseLevel > 2){
1704 G4cout << " last r " << coord1.mag() << G4endl;
1705 }
1706
1707 G4bool large_dist = false;
1708
1709 for (i = 0; i < ab-1; i++) {
1710 for (G4int j = i+1; j < ab; j++) {
1711
1712 G4double r2 = (coordinates[i]-coordinates[j]).mag2();
1713
1714 if (verboseLevel > 2){
1715 G4cout << " i " << i << " j " << j << " r2 " << r2 << G4endl;
1716 }
1717
1718 if (r2 > r_large2for4) {
1719 large_dist = true;
1720
1721 break;
1722 }
1723 }
1724
1725 if (large_dist) break;
1726 }
1727
1728 if (!large_dist) badco = false;
1729 }
1730 }
1731
1732 if(badco) {
1733 G4cout << " can not generate the nucleons coordinates for a "
1734 << ab << G4endl;
1735
1736 casparticles.clear(); // Return empty buffer on error
1737 particles.clear();
1738 return;
1739
1740 } else { // momentums
1741 G4double p, u, x;
1742 G4LorentzVector mom;
1743 //G4bool badp = True;
1744
1745 for (G4int i = 0; i < ab - 1; i++) {
1746 G4int itry2 = 0;
1747
1748 while(itry2 < itry_max) { /* Loop checking 08.06.2015 MHK */
1749 itry2++;
1750 u = -G4Log(0.879853 - 0.8798502*G4UniformRand() );
1751 x = u * G4Exp(-u);
1752
1753 if(x > G4UniformRand() ) {
1754 p = std::sqrt(0.01953 * u);
1755 mom = generateWithRandomAngles(p, massb);
1756 momentums.push_back(mom);
1757
1758 break;
1759 }
1760 } // while (itry2 < itry_max)
1761
1762 if(itry2 == itry_max) {
1763 G4cout << " can not generate proper momentum for a "
1764 << ab << G4endl;
1765
1766 casparticles.clear(); // Return empty buffer on error
1767 particles.clear();
1768 return;
1769 }
1770 } // for (i=0 ...
1771 // last momentum
1772
1773 mom *= 0.; // Cheap way to reset
1774 mom.setE(bullet->getEnergy()+target->getEnergy());
1775
1776 for(G4int j=0; j< ab-1; j++) mom -= momentums[j];
1777
1778 momentums.push_back(mom);
1779 }
1780 }
1781
1782 // Coordinates and momenta at rest are generated, now back to the lab
1783 G4double rb = 0.0;
1784 G4int i(0);
1785
1786 for(i = 0; i < G4int(coordinates.size()); i++) {
1787 G4double rp = coordinates[i].mag2();
1788
1789 if(rp > rb) rb = rp;
1790 }
1791
1792 // nuclei i.p. as a whole
1793 G4double s1 = std::sqrt(G4UniformRand() );
1794 G4double phi = randomPHI();
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));
1798
1799 for (i = 0; i < G4int(coordinates.size()); i++) {
1800 coordinates[i] += global_pos;
1801 }
1802
1803 // all nucleons at rest
1804 raw_particles.clear();
1805
1806 for (G4int ipa = 0; ipa < ab; ipa++) {
1807 G4int knd = ipa < zb ? 1 : 2;
1808 raw_particles.push_back(G4InuclElementaryParticle(momentums[ipa], knd));
1809 }
1810
1811 G4InuclElementaryParticle dummy(small_ekin, 1);
1812 G4LorentzConvertor toTheBulletRestFrame(&dummy, bullet);
1813 toTheBulletRestFrame.toTheTargetRestFrame();
1814
1815 particleIterator ipart;
1816
1817 for (ipart = raw_particles.begin(); ipart != raw_particles.end(); ipart++) {
1818 ipart->setMomentum(toTheBulletRestFrame.backToTheLab(ipart->getMomentum()));
1819 }
1820
1821 // fill cascad particles and outgoing particles
1822
1823 for(G4int ip = 0; ip < G4int(raw_particles.size()); ip++) {
1824 G4LorentzVector mom = raw_particles[ip].getMomentum();
1825 G4double pmod = mom.rho();
1826 G4double t0 = -mom.vect().dot(coordinates[ip]) / pmod;
1827 G4double det = t0 * t0 + nuclei_radius * nuclei_radius
1828 - coordinates[ip].mag2();
1829 G4double tr = -1.0;
1830
1831 if(det > 0.0) {
1832 G4double t1 = t0 + std::sqrt(det);
1833 G4double t2 = t0 - std::sqrt(det);
1834
1835 if(std::fabs(t1) <= std::fabs(t2)) {
1836 if(t1 > 0.0) {
1837 if(coordinates[ip].z() + mom.z() * t1 / pmod <= 0.0) tr = t1;
1838 }
1839
1840 if(tr < 0.0 && t2 > 0.0) {
1841
1842 if(coordinates[ip].z() + mom.z() * t2 / pmod <= 0.0) tr = t2;
1843 }
1844
1845 } else {
1846 if(t2 > 0.0) {
1847
1848 if(coordinates[ip].z() + mom.z() * t2 / pmod <= 0.0) tr = t2;
1849 }
1850
1851 if(tr < 0.0 && t1 > 0.0) {
1852 if(coordinates[ip].z() + mom.z() * t1 / pmod <= 0.0) tr = t1;
1853 }
1854 }
1855
1856 }
1857
1858 if(tr >= 0.0) { // cascad particle
1859 coordinates[ip] += mom.vect()*tr / pmod;
1860 casparticles.push_back(G4CascadParticle(raw_particles[ip],
1861 coordinates[ip],
1862 number_of_zones, large, 0));
1863
1864 } else {
1865 particles.push_back(raw_particles[ip]);
1866 }
1867 }
1868 }
1869
1870 if(casparticles.size() == 0) {
1871 particles.clear();
1872
1873 G4cout << " can not generate proper distribution for " << itry_max
1874 << " steps " << G4endl;
1875 }
1876 }
1877 }
1878
1879 if(verboseLevel > 2){
1880 G4int ip(0);
1881
1882 G4cout << " cascad particles: " << casparticles.size() << G4endl;
1883 for(ip = 0; ip < G4int(casparticles.size()); ip++)
1884 G4cout << casparticles[ip] << G4endl;
1885
1886 G4cout << " outgoing particles: " << particles.size() << G4endl;
1887 for(ip = 0; ip < G4int(particles.size()); ip++)
1888 G4cout << particles[ip] << G4endl;
1889 }
1890
1891 return; // Buffer has been filled
1892}
std::vector< G4InuclElementaryParticle >::iterator particleIterator
double dot(const Hep3Vector &) const
G4int getZ() const
G4int getA() const
G4double getMass() const
G4double getEnergy() const

◆ inverseMeanFreePath()

G4double G4NucleiModel::inverseMeanFreePath ( const G4CascadParticle & cparticle,
const G4InuclElementaryParticle & target,
G4int zone = -1 )
protected

Definition at line 1897 of file G4NucleiModel.cc.

1899 {
1900 G4int ptype = cparticle.getParticle().type();
1901 G4int ip = target.type();
1902
1903 // Ensure that zone specified is within nucleus, for array lookups
1904 if (zone<0) zone = cparticle.getCurrentZone();
1905 if (zone>=number_of_zones) zone = number_of_zones-1;
1906
1907 // Special cases: neutrinos, and muon-on-neutron, have infinite path
1908 if (cparticle.getParticle().isNeutrino()) return 0.;
1909 if (ptype == muonMinus && ip == neutron) return 0.;
1910
1911 // Configure frame transformation to get kinetic energy for lookups
1912 dummy_convertor.setBullet(cparticle.getParticle());
1913 dummy_convertor.setTarget(&target);
1914 dummy_convertor.toTheCenterOfMass(); // Fill internal kinematics
1915 G4double ekin = dummy_convertor.getKinEnergyInTheTRS();
1916
1917 // Get cross section for interacting with target (dibaryons are absorptive)
1918 G4double csec = (ip < 100) ? totalCrossSection(ekin, ptype*ip)
1919 : absorptionCrossSection(ekin, ptype);
1920
1921 if (verboseLevel > 2) {
1922 G4cout << " ip " << ip << " zone " << zone << " ekin " << ekin
1923 << " dens " << getCurrentDensity(ip, zone)
1924 << " csec " << csec << G4endl;
1925 }
1926
1927 if (csec <= 0.) return 0.; // No interaction, avoid unnecessary work
1928
1929 // Get nuclear density and compute mean free path
1930 return csec * getCurrentDensity(ip, zone);
1931}
G4double getCurrentDensity(G4int ip, G4int izone) const
G4double totalCrossSection(G4double ke, G4int rtype) const
G4double absorptionCrossSection(G4double e, G4int type) const

Referenced by choosePointAlongTraj(), and generateInteractionPartners().

◆ isProjectile()

G4bool G4NucleiModel::isProjectile ( const G4CascadParticle & cparticle) const

Definition at line 1348 of file G4NucleiModel.cc.

1348 {
1349 return (cparticle.getGeneration() == 0); // Only initial state particles
1350}

Referenced by forceFirst(), and generateInteractionPartners().

◆ passFermi()

G4bool G4NucleiModel::passFermi ( const std::vector< G4InuclElementaryParticle > & particles,
G4int zone )
protected

Definition at line 1072 of file G4NucleiModel.cc.

1073 {
1074 if (verboseLevel > 1) {
1075 G4cout << " >>> G4NucleiModel::passFermi" << G4endl;
1076 }
1077
1078 // Only check Fermi momenta for nucleons
1079 for (G4int i = 0; i < G4int(particles.size()); i++) {
1080 if (!particles[i].nucleon()) continue;
1081
1082 G4int type = particles[i].type();
1083 G4double mom = particles[i].getMomModule();
1084 G4double pfermi = fermi_momenta[type-1][zone];
1085
1086 if (verboseLevel > 2)
1087 G4cout << " type " << type << " p " << mom << " pf " << pfermi << G4endl;
1088
1089 if (mom < pfermi) {
1090 if (verboseLevel > 2) G4cout << " rejected by Fermi" << G4endl;
1091 return false;
1092 }
1093 }
1094 return true;
1095}
G4bool nucleon(G4int ityp)

Referenced by generateParticleFate().

◆ passTrailing()

G4bool G4NucleiModel::passTrailing ( const G4ThreeVector & hit_position)
protected

Definition at line 1101 of file G4NucleiModel.cc.

1101 {
1102 if (verboseLevel > 1)
1103 G4cout << " >>> G4NucleiModel::passTrailing " << hit_position << G4endl;
1104
1105 G4double dist;
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;
1111 return false;
1112 }
1113 }
1114 return true; // New point far enough away to be used
1115}

Referenced by generateParticleFate().

◆ printModel()

void G4NucleiModel::printModel ( ) const

Definition at line 615 of file G4NucleiModel.cc.

615 {
616 if (verboseLevel > 1) {
617 G4cout << " >>> G4NucleiModel::printModel" << G4endl;
618 }
619
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;
625
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 " <<
630 getFermiMomentum(1,i) << " VP " << getPotential(1,i) << G4endl
631 << " neutrons: density " << getDensity(2,i) << " PF " <<
632 getFermiMomentum(2,i) << " VP " << getPotential(2,i) << G4endl
633 << " pions: VP " << getPotential(3,i) << G4endl;
634}

Referenced by generateModel().

◆ reset()

void G4NucleiModel::reset ( G4int nHitNeutrons = 0,
G4int nHitProtons = 0,
const std::vector< G4ThreeVector > * hitPoints = 0 )

Definition at line 299 of file G4NucleiModel.cc.

300 {
301 neutronNumberCurrent = neutronNumber - nHitNeutrons;
302 protonNumberCurrent = protonNumber - nHitProtons;
303
304 // zero or copy collision point array for trailing effect
305 if (!hitPoints || !hitPoints->empty()) collisionPts.clear();
306 else collisionPts = *hitPoints;
307}

Referenced by generateModel().

◆ setDinucleonDensityScale()

void G4NucleiModel::setDinucleonDensityScale ( )
protected

Definition at line 1400 of file G4NucleiModel.cc.

1400 {
1401 if (A < 5) {
1402 dinucleonDensityScale = 1.0;
1403 // No scaling for light nuclei
1404 return;
1405 }
1406
1407 // At what A should LDA start to be applied?
1408 // Not satisfactory for medium nuclei according to Benhar et al., and a
1409 // sizable experimental uncertainty
1410
1411 // Levinger factor
1412 const G4double Levinger_LDA {10.83 - 9.73/G4Pow::GetInstance()->A13(A)};
1413
1414 // Effective number of quasi-deuterons in a nucleus according to
1415 // local density approximation
1416 const G4double num_LDA_QDs {(Levinger_LDA*Z*(A-Z))/A};
1417
1418 // Number of quasi-deuterons expected from proton and neutron nuclear
1419 // shell densities alone
1420 G4double num_Naive_QDs{0.};
1421 for (G4int zone = 0; zone < number_of_zones; ++zone) {
1422 num_Naive_QDs += getVolume(zone)*getDensity(proton, zone)*
1423 getVolume(zone)*getDensity(neutron, zone);
1424 }
1425
1426 // Density scaling factor determined for quasi-deuterons to be used
1427 // for pp, nn, pn
1428 dinucleonDensityScale = num_LDA_QDs/num_Naive_QDs;
1429
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;
1437 }
1438}
static G4Pow * GetInstance()
Definition G4Pow.cc:41
G4double A13(G4double A) const
Definition G4Pow.cc:116

Referenced by generateModel().

◆ setVerboseLevel()

void G4NucleiModel::setVerboseLevel ( G4int verbose)
inline

Definition at line 99 of file G4NucleiModel.hh.

99{ verboseLevel = verbose; }

◆ sortPartners()

static G4bool G4NucleiModel::sortPartners ( const partner & p1,
const partner & p2 )
inlinestaticprotected

Definition at line 209 of file G4NucleiModel.hh.

209 {
210 return (p2.second > p1.second);
211 }

Referenced by generateInteractionPartners().

◆ stillInside()

G4bool G4NucleiModel::stillInside ( const G4CascadParticle & cparticle)
inline

Definition at line 154 of file G4NucleiModel.hh.

154 {
155 return cparticle.getCurrentZone() < number_of_zones;
156 }

◆ totalCrossSection()

G4double G4NucleiModel::totalCrossSection ( G4double ke,
G4int rtype ) const

Definition at line 2000 of file G4NucleiModel.cc.

2001{
2002 // All scattering cross-sections are available from tables
2003 const G4CascadeChannel* xsecTable = G4CascadeChannelTables::GetTable(rtype);
2004 if (!xsecTable) {
2005 G4cerr << " unknown collison type = " << rtype << G4endl;
2006 return 0.;
2007 }
2008
2009 return (crossSectionUnits * xsecTable->getCrossSection(ke));
2010}
static const G4CascadeChannel * GetTable(G4int initialState)
virtual G4double getCrossSection(double ke) const =0

Referenced by inverseMeanFreePath().

◆ useQuasiDeuteron()

G4bool G4NucleiModel::useQuasiDeuteron ( G4int ptype,
G4int qdtype = 0 )
static

Definition at line 1060 of file G4NucleiModel.cc.

1060 {
1061 if (qdtype==pn || qdtype==0) // All absorptive particles
1062 return (ptype==pi0 || ptype==pip || ptype==pim || ptype==gam || ptype==mum);
1063 else if (qdtype==pp) // Negative or neutral only
1064 return (ptype==pi0 || ptype==pim || ptype==gam || ptype==mum);
1065 else if (qdtype==nn) // Positive or neutral only
1066 return (ptype==pi0 || ptype==pip || ptype==gam);
1067
1068 return false; // Not a quasideuteron target
1069}

Referenced by absorptionCrossSection(), G4ElementaryParticleCollider::collide(), and generateInteractionPartners().

◆ worthToPropagate()

G4bool G4NucleiModel::worthToPropagate ( const G4CascadParticle & cparticle) const

Definition at line 1352 of file G4NucleiModel.cc.

1352 {
1353 if (verboseLevel > 1) {
1354 G4cout << " >>> G4NucleiModel::worthToPropagate" << G4endl;
1355 }
1356
1357 const G4double ekin_scale = 2.0;
1358
1359 G4bool worth = true;
1360
1361 if (cparticle.reflectedNow()) { // Just reflected -- keep going?
1362 G4int zone = cparticle.getCurrentZone();
1363 G4int ip = cparticle.getParticle().type();
1364
1365 // NOTE: Temporarily backing out use of potential for non-nucleons
1366 G4double ekin_cut = (cparticle.getParticle().nucleon()) ?
1367 getFermiKinetic(ip, zone) : 0.; //*** getPotential(ip, zone);
1368
1369 worth = cparticle.getParticle().getKineticEnergy()/ekin_scale > ekin_cut;
1370
1371 if (verboseLevel > 3) {
1372 G4cout << " type=" << ip
1373 << " ekin=" << cparticle.getParticle().getKineticEnergy()
1374 << " potential=" << ekin_cut
1375 << " : worth? " << worth << G4endl;
1376 }
1377 }
1378
1379 return worth;
1380}
G4bool reflectedNow() const
G4double getFermiKinetic(G4int ip, G4int izone) const

◆ zoneIntegralGaussian()

G4double G4NucleiModel::zoneIntegralGaussian ( G4double ur1,
G4double ur2,
G4double nuclearRadius ) const
protected

Definition at line 567 of file G4NucleiModel.cc.

568 {
569 if (verboseLevel > 1) {
570 G4cout << " >>> G4NucleiModel::zoneIntegralGaussian" << G4endl;
571 }
572
573 G4double gaussRadius = std::sqrt(nucRad*nucRad * (1.0 - 1.0/A) + 6.4);
574
575 const G4double epsilon = 1.0e-3;
576 const G4int itry_max = 1000;
577
578 G4double dr = r2 - r1;
579 G4double fr1 = r1 * r1 * G4Exp(-r1 * r1);
580 G4double fr2 = r2 * r2 * G4Exp(-r2 * r2);
581 G4double fi = (fr1 + fr2) / 2.;
582 G4double fun1 = fi * dr;
583 G4double fun;
584 G4int jc = 1;
585 G4double dr1 = dr;
586 G4int itry = 0;
587
588 while (itry < itry_max) { /* Loop checking 08.06.2015 MHK */
589 dr /= 2.;
590 itry++;
591 G4double r = r1 - dr;
592 fi = 0.0;
593
594 for (G4int i = 0; i < jc; i++) {
595 r += dr1;
596 fi += r * r * G4Exp(-r * r);
597 }
598
599 fun = 0.5 * fun1 + fi * dr;
600
601 if (std::fabs((fun - fun1) / fun) <= epsilon) break;
602
603 jc *= 2;
604 dr1 = dr;
605 fun1 = fun;
606 } // while (itry < itry_max)
607
608 if (verboseLevel > 2 && itry == itry_max)
609 G4cerr << " zoneIntegralGaussian-> n iter " << itry_max << G4endl;
610
611 return gaussRadius*gaussRadius*gaussRadius * fun;
612}
G4double epsilon(G4double density, G4double temperature)

Referenced by fillZoneVolumes().

◆ zoneIntegralWoodsSaxon()

G4double G4NucleiModel::zoneIntegralWoodsSaxon ( G4double ur1,
G4double ur2,
G4double nuclearRadius ) const
protected

Definition at line 514 of file G4NucleiModel.cc.

515 {
516 if (verboseLevel > 1) {
517 G4cout << " >>> G4NucleiModel::zoneIntegralWoodsSaxon" << G4endl;
518 }
519
520 const G4double epsilon = 1.0e-3;
521 const G4int itry_max = 1000;
522
523 G4double skinRatio = nuclearRadius / skinDepth;
524
525 G4double d2 = 2.0 * skinRatio;
526 G4double dr = r2 - r1;
527 G4double fr1 = r1 * (r1 + d2) / (1.0 + G4Exp(r1));
528 G4double fr2 = r2 * (r2 + d2) / (1.0 + G4Exp(r2));
529 G4double fi = (fr1 + fr2) / 2.;
530 G4double fun1 = fi * dr;
531 G4double fun;
532 G4int jc = 1;
533 G4double dr1 = dr;
534 G4int itry = 0;
535
536 while (itry < itry_max) { /* Loop checking 08.06.2015 MHK */
537 dr /= 2.;
538 itry++;
539
540 G4double r = r1 - dr;
541 fi = 0.0;
542
543 for (G4int i = 0; i < jc; i++) {
544 r += dr1;
545 fi += r * (r + d2) / (1.0 + G4Exp(r));
546 }
547
548 fun = 0.5 * fun1 + fi * dr;
549
550 if (std::fabs((fun - fun1) / fun) <= epsilon) break;
551
552 jc *= 2;
553 dr1 = dr;
554 fun1 = fun;
555 } // while (itry < itry_max)
556
557 if (verboseLevel > 2 && itry == itry_max)
558 G4cout << " zoneIntegralWoodsSaxon-> n iter " << itry_max << G4endl;
559
560 G4double skinDepth3 = skinDepth*skinDepth*skinDepth;
561
562 return skinDepth3 * (fun + skinRatio*skinRatio*G4Log((1.0 + G4Exp(-r1)) / (1.0 + G4Exp(-r2))));
563}

Referenced by fillZoneVolumes().

Member Data Documentation

◆ thePartners

std::vector<partner> G4NucleiModel::thePartners
protected

Definition at line 205 of file G4NucleiModel.hh.

Referenced by generateInteractionPartners(), and generateParticleFate().


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