89 {
"DEDX",
"Ionisation",
"DEDXnr",
"CSDARange",
"Lambda",
"Range",
"InverseRange"};
101 lowestKinEnergy = theParameters->LowestElectronEnergy();
104 minKinEnergy = 0.1*CLHEP::keV;
105 maxKinEnergy = 100.0*CLHEP::TeV;
106 maxKinEnergyCSDA = 1.0*CLHEP::GeV;
110 invLambdaFactor = 1.0/lambdaFactor;
113 finalRange = 1.*CLHEP::mm;
125 lManager->Register(
this);
126 isMaster = lManager->IsMaster();
132 scTracks.reserve(10);
133 secParticles.reserve(12);
134 emModels =
new std::vector<G4VEmModel*>;
142 if(
nullptr == baseParticle) {
delete theData; }
143 delete theEnergyOfCrossSectionMax;
144 if(
nullptr != fXSpeaks) {
145 for(
auto const & v : *fXSpeaks) {
delete v; }
153 lManager->DeRegister(
this);
171 if(
nullptr == ptr) {
return; }
173 modelManager->AddEmModel(order, ptr, afluc, region);
181 if(
nullptr == ptr) {
return; }
182 if(!emModels->empty()) {
183 for(
auto & em : *emModels) {
if(em == ptr) {
return; } }
185 emModels->push_back(ptr);
193 massRatio = massratio;
194 logMassRatio =
G4Log(massRatio);
195 fFactor = charge2ratio*biasFactor;
197 chargeSqRatio = charge2ratio;
198 reduceFactor = 1.0/(fFactor*massRatio);
209 if( particle != &part ) {
210 if(!isIon) { lManager->RegisterExtraParticle(&part,
this); }
212 G4cout <<
"### G4VEnergyLossProcess::PreparePhysicsTable()"
215 <<
" spline=" << spline <<
G4endl;
220 tablesAreBuilt =
false;
224 lManager->PreparePhysicsTable(&part,
this);
230 if(!actLossFluc) { lossFluctuationFlag = theParameters->LossFluctuation(); }
231 useCutAsFinalRange = theParameters->UseCutAsFinalRange();
232 if(!actMinKinEnergy) { minKinEnergy = theParameters->MinKinEnergy(); }
233 if(!actMaxKinEnergy) { maxKinEnergy = theParameters->MaxKinEnergy(); }
234 if(!actBinning) { nBins = theParameters->NumberOfBins(); }
235 maxKinEnergyCSDA = theParameters->MaxEnergyForCSDARange();
236 nBinsCSDA = theParameters->NumberOfBinsPerDecade()
237 *
G4lrint(std::log10(maxKinEnergyCSDA/minKinEnergy));
238 if(!actLinLossLimit) { linLossLimit = theParameters->LinearLossLimit(); }
239 lambdaFactor = theParameters->LambdaFactor();
240 invLambdaFactor = 1.0/lambdaFactor;
246 theParameters->DefineRegParamForLoss(
this);
250 G4double initialCharge = particle->GetPDGCharge();
251 G4double initialMass = particle->GetPDGMass();
253 theParameters->FillStepFunction(particle,
this);
256 if (
nullptr != baseParticle) {
257 massRatio = (baseParticle->GetPDGMass())/initialMass;
258 logMassRatio =
G4Log(massRatio);
259 G4double q = initialCharge/baseParticle->GetPDGCharge();
261 if(chargeSqRatio > 0.0) { reduceFactor = 1.0/(chargeSqRatio*massRatio); }
263 lowestKinEnergy = (initialMass < CLHEP::MeV)
264 ? theParameters->LowestElectronEnergy()
265 : theParameters->LowestMuHadEnergy();
268 if (isMaster &&
nullptr == baseParticle) {
271 if(
nullptr != theDEDXTable && isIonisation) {
272 if(
nullptr != theIonisationTable && theDEDXTable != theIonisationTable) {
273 theData->CleanTable(0);
274 theDEDXTable = theIonisationTable;
275 theIonisationTable =
nullptr;
279 theDEDXTable = theData->MakeTable(theDEDXTable, 0);
281 theData->UpdateTable(theIonisationTable, 1);
283 if (theParameters->BuildCSDARange()) {
284 theDEDXunRestrictedTable = theData->MakeTable(2);
285 if(isIonisation) { theCSDARangeTable = theData->MakeTable(3); }
288 theLambdaTable = theData->MakeTable(4);
290 theRangeTableForLoss = theData->MakeTable(5);
291 theInverseRangeTable = theData->MakeTable(6);
296 if(
nullptr != biasManager) {
301 numberOfModels = modelManager->NumberOfModels();
302 currentModel = modelManager->GetModel(0);
304 numberOfModels, secID, biasID,
305 mainSecondaries, baseMat, isMaster,
306 theParameters->UseAngularGeneratorForIonisation());
307 theCuts = modelManager->Initialise(particle, secondaryParticle,
311 subcutProducer = lManager->SubCutProducer();
313 if(1 == nSCoffRegions) {
314 if((*scoffRegions)[0]->GetName() ==
"DefaultRegionForTheWorld") {
316 scoffRegions =
nullptr;
322 G4cout <<
"G4VEnergyLossProcess::PrepearPhysicsTable() is done "
323 <<
" for " <<
GetProcessName() <<
" and " << particle->GetParticleName()
324 <<
" isIon= " << isIon <<
" spline=" << spline;
326 G4cout <<
"; base: " << baseParticle->GetParticleName();
329 G4cout <<
" chargeSqRatio= " << chargeSqRatio
330 <<
" massRatio= " << massRatio
331 <<
" reduceFactor= " << reduceFactor <<
G4endl;
332 if (nSCoffRegions > 0) {
333 G4cout <<
" SubCut secondary production is ON for regions: " <<
G4endl;
334 for (
G4int i=0; i<nSCoffRegions; ++i) {
335 const G4Region* r = (*scoffRegions)[i];
338 }
else if(
nullptr != subcutProducer) {
339 G4cout <<
" SubCut secondary production is ON for all regions" <<
G4endl;
349 G4cout <<
"### G4VEnergyLossProcess::BuildPhysicsTable() for "
352 <<
"; the first particle " << particle->GetParticleName();
354 G4cout <<
"; base: " << baseParticle->GetParticleName();
357 G4cout <<
" TablesAreBuilt= " << tablesAreBuilt <<
" isIon= " << isIon
358 <<
" spline=" << spline <<
" ptr: " <<
this <<
G4endl;
361 if(&part == particle) {
363 lManager->BuildPhysicsTable(particle,
this);
366 const auto masterProcess =
369 numberOfModels = modelManager->NumberOfModels();
371 particle, numberOfModels);
372 tablesAreBuilt =
true;
373 baseMat = masterProcess->UseBaseMaterial();
374 lManager->LocalPhysicsTables(particle,
this);
378 safetyHelper->InitialiseHelper();
383 atomDeexcitation = lManager->AtomDeexcitation();
384 if(
nullptr != atomDeexcitation) {
385 if(atomDeexcitation->IsPIXEActive()) { useDeexcitation =
true; }
390 if(theParameters->IsPrintLocked()) {
return; }
396 num ==
"e+" || num ==
"mu+" ||
397 num ==
"mu-" || num ==
"proton"||
398 num ==
"pi+" || num ==
"pi-" ||
399 num ==
"kaon+" || num ==
"kaon-" ||
400 num ==
"alpha" || num ==
"anti_proton" ||
401 num ==
"GenericIon"|| num ==
"alpha+" ))) {
405 G4cout <<
"### G4VEnergyLossProcess::BuildPhysicsTable() done for "
408 if(isIonisation) {
G4cout <<
" isIonisation flag=1"; }
422 emax = maxKinEnergyCSDA;
424 table = theDEDXunRestrictedTable;
426 table = theDEDXTable;
428 G4cout <<
"G4VEnergyLossProcess::BuildDEDXTable WARNING: wrong type "
432 G4cout <<
"G4VEnergyLossProcess::BuildDEDXTable() of type " << tType
434 <<
" and " << particle->GetParticleName()
435 <<
"spline=" << spline <<
G4endl;
437 if(
nullptr == table) {
return table; }
441 table, minKinEnergy, emax, bin,
450 if(
nullptr == theLambdaTable) {
return theLambdaTable; }
452 G4double scale = theParameters->MaxKinEnergy()/theParameters->MinKinEnergy();
454 theParameters->NumberOfBinsPerDecade()*
G4lrint(std::log10(scale));
455 scale = nbin/
G4Log(scale);
459 bld, theLambdaTable, theCuts,
460 minKinEnergy, maxKinEnergy, scale,
462 return theLambdaTable;
467void G4VEnergyLossProcess::StreamInfo(std::ostream& out,
471 out << std::setprecision(6);
474 out <<
" XStype:" << fXSType
476 <<
" dE/dx and range tables from "
478 <<
" to " <<
G4BestUnit(maxKinEnergy,
"Energy")
479 <<
" in " << nBins <<
" bins" <<
G4endl
480 <<
" Lambda tables from threshold to "
483 <<
" bins/decade, spline: " << spline
485 if(
nullptr != theRangeTableForLoss && isIonisation) {
486 out <<
" StepFunction=(" << dRoverRange <<
", "
487 << finalRange/mm <<
" mm)"
488 <<
", integ: " << fXSType
489 <<
", fluct: " << lossFluctuationFlag
490 <<
", linLossLim= " << linLossLimit
495 if(
nullptr != theCSDARangeTable && isIonisation) {
496 out <<
" CSDA range table up"
497 <<
" to " <<
G4BestUnit(maxKinEnergyCSDA,
"Energy")
498 <<
" in " << nBinsCSDA <<
" bins" <<
G4endl;
500 if(nSCoffRegions>0 && isIonisation) {
501 out <<
" Subcutoff sampling in " << nSCoffRegions
505 for(std::size_t i=0; i<7; ++i) {
506 auto ta = theData->Table(i);
507 out <<
" " << tnames[i] <<
" address: " << ta <<
G4endl;
508 if(
nullptr != ta) { out << *ta <<
G4endl; }
517 if(
nullptr == scoffRegions) {
518 scoffRegions =
new std::vector<const G4Region*>;
521 if(!scoffRegions->empty()) {
522 for (
auto & reg : *scoffRegions) {
523 if (reg == r) {
return; }
527 scoffRegions->push_back(r);
533G4bool G4VEnergyLossProcess::IsRegionForCubcutProcessor(
const G4Track& aTrack)
535 if(0 == nSCoffRegions) {
return true; }
537 for(
auto & reg : *scoffRegions) {
538 if(r == reg) {
return true; }
556 massRatio = (
nullptr == baseParticle) ? CLHEP::proton_mass_c2/newmass
557 : baseParticle->GetPDGMass()/newmass;
558 logMassRatio =
G4Log(massRatio);
561 if(
nullptr != biasManager) {
564 biasManager->ResetForcedInteraction();
576 *selection = aGPILSelection;
579 x = (useCutAsFinalRange) ? std::min(finalRange,
580 currentCouple->GetProductionCuts()->GetProductionCut(1)) : finalRange;
581 x = (fRange > x) ? fRange*dRoverRange + x*(1.0 - dRoverRange)*(2.0 - x/fRange)
619 const G4double q2 = currentModel->ChargeSquareRatio(track);
620 fFactor = q2*biasFactor;
622 reduceFactor = 1.0/(fFactor*massRatio);
623 if (lossFluctuationFlag) {
624 auto fluc = currentModel->GetModelOfFluctuations();
668 G4cout <<
"G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength ";
676 <<
"InteractionLength= " << x/cm <<
"[cm] " <<
G4endl;
685G4VEnergyLossProcess::ComputeLambdaForScaledEnergy(
G4double e,
const G4Track& track)
690 preStepLambda = GetLambdaForScaledEnergy(e, LogScaledEkin(track));
696 const G4double epeak = (*theEnergyOfCrossSectionMax)[basedCoupleIndex];
699 preStepLambda = GetLambdaForScaledEnergy(e, LogScaledEkin(track));
703 const G4double e1 = std::max(epeak, e*lambdaFactor);
710 G4TwoPeaksXS* xs = (*fXSpeaks)[basedCoupleIndex];
716 preStepLambda = GetLambdaForScaledEnergy(e, LogScaledEkin(track));
725 const G4double e1 = std::max(e1peak, e*lambdaFactor);
736 preStepLambda = GetLambdaForScaledEnergy(e, LogScaledEkin(track));
744 const G4double e1 = std::max(e2peak, e*lambdaFactor);
755 preStepLambda = GetLambdaForScaledEnergy(e, LogScaledEkin(track));
761 const G4double e1 = std::max(e3peak, e*lambdaFactor);
767 preStepLambda = GetLambdaForScaledEnergy(e, LogScaledEkin(track));
802 weight /= biasFactor;
809 if (useDeexcitation) {
810 atomDeexcitation->AlongStepDeexcitation(scTracks, step,
812 if(scTracks.size() > 0) { FillSecondariesAlongStep(weight); }
813 eloss = std::max(eloss, 0.0);
824 LogScaledEkin(track));
836 const G4double x = (fRange - length)/reduceFactor;
838 if(de > 0.0) { eloss = de; }
865 currentModel->CorrectionsAlongStep(
currentCouple, dynParticle,
867 eloss = std::max(eloss, 0.0);
874 }
else if (lossFluctuationFlag) {
875 const G4double tmax = currentModel->MaxSecondaryKinEnergy(dynParticle);
876 const G4double tcut = std::min(cut, tmax);
879 tcut, tmax, length, eloss);
890 if (useDeexcitation) {
893 atomDeexcitation->AlongStepDeexcitation(scTracks, step,
900 if(eloss >= esecfluo) {
908 if(
nullptr != subcutProducer && IsRegionForCubcutProcessor(track)) {
909 subcutProducer->SampleSecondaries(step, scTracks, eloss, cut);
912 if(!scTracks.empty()) { FillSecondariesAlongStep(weight); }
916 if (finalT <= lowestKinEnergy) {
924 eloss = std::max(eloss, 0.0);
945void G4VEnergyLossProcess::FillSecondariesAlongStep(
G4double wt)
947 const std::size_t n0 = scTracks.size();
958 const std::size_t
n = scTracks.size();
961 for(std::size_t i=0; i<
n; ++i) {
962 G4Track* t = scTracks[i];
970 }
else if (pdg == 11) {
995 const G4double postStepScaledEnergy = finalT*massRatio;
998 if(!currentModel->IsActive(postStepScaledEnergy)) {
1017 G4double lx = GetLambdaForScaledEnergy(postStepScaledEnergy,
1018 logFinalT + logMassRatio);
1019 lx = std::max(lx, 0.0);
1030 weight /= biasFactor;
1037 secParticles.clear();
1038 currentModel->SampleSecondaries(&secParticles,
currentCouple, dp, tcut);
1040 const G4int num0 = (
G4int)secParticles.size();
1046 weight *= biasManager->ApplySecondaryBiasing(
1048 track, currentModel,
1060 const G4int num = (
G4int)secParticles.size();
1067 if(num0 > mainSecondaries) {
1068 currentModel->FillNumberOfSecondaries(n1, n2);
1071 for (
G4int i=0; i<num; ++i) {
1072 if(
nullptr != secParticles[i]) {
1076 t->
SetWeight(weight * biasManager->GetWeight(i));
1082 }
else if(i < num0 + n1) {
1098 if(particle->GetProcessManager()->GetAtRestProcessVector()->size() > 0)
1123 if (!isMaster ||
nullptr != baseParticle || part != particle )
return true;
1124 for(std::size_t i=0; i<7; ++i) {
1126 if (
nullptr == theData->Table(i) || (!isIonisation && 1 == i)) {
1130 G4cout <<
"G4VEnergyLossProcess::StorePhysicsTable i=" << i
1131 <<
" " << particle->GetParticleName()
1133 <<
" " << tnames[i] <<
" " << theData->Table(i) <<
G4endl;
1149 if (!isMaster ||
nullptr != baseParticle || part != particle )
return true;
1150 for(std::size_t i=0; i<7; ++i) {
1152 if (!isIonisation && 1 == i) {
continue; }
1168 DefineMaterial(couple);
1171 G4double tmax = currentModel->MaxSecondaryKinEnergy(dp);
1187 DefineMaterial(couple);
1189 if (
nullptr != theLambdaTable) {
1190 cross = GetLambdaForScaledEnergy(kineticEnergy * massRatio,
1191 logKineticEnergy + logMassRatio);
1194 cross = (!baseMat) ? biasFactor : biasFactor*(*theDensityFactor)[
currentCoupleIndex];
1195 cross *= (currentModel->CrossSectionPerVolume(
currentMaterial, particle, kineticEnergy,
1198 return std::max(cross, 0.0);
1208 const G4double cs = GetLambdaForScaledEnergy(kinEnergy * massRatio,
1209 logKinEnergy + logMassRatio);
1210 return (0.0 < cs) ? 1.0/cs :
DBL_MAX;
1249 DefineMaterial(couple);
1260 G4cout <<
"### Set DEDX table " << p <<
" " << theDEDXTable
1261 <<
" " << theDEDXunRestrictedTable <<
" " << theIonisationTable
1262 <<
" for " << particle->GetParticleName()
1264 <<
" type=" << tType <<
" isIonisation:" << isIonisation <<
G4endl;
1267 theDEDXunRestrictedTable = p;
1270 if(isMaster &&
nullptr == baseParticle) {
1271 theData->UpdateTable(theDEDXTable, 0);
1274 theIonisationTable = p;
1275 if(isMaster &&
nullptr == baseParticle) {
1276 theData->UpdateTable(theIonisationTable, 1);
1285 theCSDARangeTable = p;
1292 theRangeTableForLoss = p;
1299 theInverseRangeTable = p;
1307 G4cout <<
"### Set Lambda table " << p <<
" " << theLambdaTable
1308 <<
" for " << particle->GetParticleName()
1312 tablesAreBuilt =
true;
1314 if(isMaster &&
nullptr != p) {
1315 delete theEnergyOfCrossSectionMax;
1316 theEnergyOfCrossSectionMax =
nullptr;
1318 if(
nullptr != fXSpeaks) {
1319 for(
auto & ptr : *fXSpeaks) {
delete ptr; }
1324 if(
nullptr == fXSpeaks) { fXSType =
fEmOnePeak; }
1328 if(
nullptr == theEnergyOfCrossSectionMax) { fXSType =
fEmIncreasing; }
1337 theEnergyOfCrossSectionMax = p;
1351 return (
nullptr != currentModel)
1364 G4cout <<
"### SetCrossSectionBiasingFactor: for "
1366 <<
" biasFactor= " << f <<
" weightFlag= " << flag
1380 G4cout <<
"### ActivateForcedInteraction: for "
1382 <<
" length(mm)= " << length/mm
1383 <<
" in G4Region <" << region
1384 <<
"> weightFlag= " << flag
1388 biasManager->ActivateForcedInteraction(length, region);
1398 if (0.0 <= factor) {
1404 biasManager->ActivateSecondaryBiasing(region, factor, energyLimit);
1406 G4cout <<
"### ActivateSecondaryBiasing: for "
1408 <<
" factor= " << factor
1409 <<
" in G4Region <" << region
1410 <<
"> energyLimit(MeV)= " << energyLimit/MeV
1428 if(0.0 < val && val < 1.0) {
1430 actLinLossLimit =
true;
1431 }
else { PrintWarning(
"SetLinearLossLimit", val); }
1438 if(0.0 < v1 && 0.0 < v2) {
1439 dRoverRange = std::min(1.0, v1);
1440 finalRange = std::min(v2, 1.e+50);
1442 PrintWarning(
"SetStepFunctionV1", v1);
1443 PrintWarning(
"SetStepFunctionV2", v2);
1451 if(1.e-18 < val && val < 1.e+50) { lowestKinEnergy = val; }
1452 else { PrintWarning(
"SetLowestEnergyLimit", val); }
1459 if(2 < n && n < 1000000000) {
1464 PrintWarning(
"SetDEDXBinning", e);
1472 if(1.e-18 < e && e < maxKinEnergy) {
1474 actMinKinEnergy =
true;
1475 }
else { PrintWarning(
"SetMinKinEnergy", e); }
1482 if(minKinEnergy < e && e < 1.e+50) {
1484 actMaxKinEnergy =
true;
1485 if(e < maxKinEnergyCSDA) { maxKinEnergyCSDA = e; }
1486 }
else { PrintWarning(
"SetMaxKinEnergy", e); }
1491void G4VEnergyLossProcess::PrintWarning(
const G4String& tit,
G4double val)
const
1493 G4String ss =
"G4VEnergyLossProcess::" + tit;
1495 ed <<
"Parameter is out of range: " << val
1496 <<
" it will have no effect!\n" <<
" Process "
1498 <<
" Emin(keV)= " << minKinEnergy/keV
1499 <<
" Emax(GeV)= " << maxKinEnergy/GeV;
1507 if(
nullptr != particle) { StreamInfo(out, *particle,
true); }
G4double condition(const G4ErrorSymMatrix &m)
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
std::ostringstream G4ExceptionDescription
@ NotCandidateForSelection
G4double G4Log(G4double x)
G4GLOB_DLL std::ostream G4cout
G4double GetLogKineticEnergy() const
G4double GetKineticEnergy() const
static G4Electron * Electron()
G4double ApplySecondaryBiasing(std::vector< G4DynamicParticle * > &, const G4Track &track, G4VEmModel *currentModel, G4ParticleChangeForGamma *pParticleChange, G4double &eloss, G4int coupleIdx, G4double tcut, G4double safety=0.0)
G4bool SecondaryBiasingRegion(G4int coupleIdx)
static G4EmParameters * Instance()
G4int NumberOfBinsPerDecade() const
static G4bool RetrieveTable(G4VProcess *ptr, const G4ParticleDefinition *part, G4PhysicsTable *aTable, const G4String &dir, const G4String &tname, const G4int verb, const G4bool ascii, const G4bool spline)
static void UpdateModels(G4VEnergyLossProcess *proc, G4EmModelManager *modelManager, const G4double maxKinEnergy, const G4int nModels, G4int &secID, G4int &biasID, G4int &mainSecondaries, const G4bool baseMat, const G4bool isMaster, const G4bool useAGen)
static void BuildLocalElossProcess(G4VEnergyLossProcess *proc, const G4VEnergyLossProcess *masterProc, const G4ParticleDefinition *part, const G4int nModels)
static G4bool StoreTable(G4VProcess *, const G4ParticleDefinition *, G4PhysicsTable *, const G4String &dir, const G4String &tname, G4int verb, G4bool ascii)
static void BuildDEDXTable(G4VEnergyLossProcess *proc, const G4ParticleDefinition *part, G4EmModelManager *modelManager, G4LossTableBuilder *bld, G4PhysicsTable *table, const G4double minKinEnergy, const G4double maxKinEnergy, const G4int nbins, const G4int verbose, const G4EmTableType tType, const G4bool splineFlag)
static const G4ParticleDefinition * CheckIon(G4VEnergyLossProcess *proc, const G4ParticleDefinition *part, const G4ParticleDefinition *particle, const G4int verboseLevel, G4bool &isIon)
static void BuildLambdaTable(G4VEmProcess *proc, const G4ParticleDefinition *part, G4EmModelManager *modelManager, G4LossTableBuilder *bld, G4PhysicsTable *theLambdaTable, G4PhysicsTable *theLambdaTablePrim, const G4double minKinEnergy, const G4double minKinEnergyPrim, const G4double maxKinEnergy, const G4double scale, const G4int verbose, const G4bool startFromNull, const G4bool splineFlag)
static std::vector< G4TwoPeaksXS * > * FillPeaksStructure(G4PhysicsTable *, G4LossTableBuilder *)
static std::vector< G4double > * FindCrossSectionMax(G4PhysicsTable *)
G4Region * GetRegion() const
static G4bool GetBaseMaterialFlag()
static const std::vector< G4double > * GetDensityFactors()
void InitialiseBaseMaterials(const G4PhysicsTable *table=nullptr)
static const std::vector< G4int > * GetCoupleIndexes()
static G4LossTableManager * Instance()
const G4String & GetName() const
G4double GetPDGMass() const
G4int GetPDGEncoding() const
const G4String & GetParticleName() const
const G4String & GetName() const
G4double GetSafety() const
G4double GetStepLength() const
G4StepPoint * GetPostStepPoint() const
const G4ParticleDefinition * GetParticleDefinition() const
G4VPhysicalVolume * GetVolume() const
void SetWeight(G4double aValue)
const G4ThreeVector & GetPosition() const
void SetTouchableHandle(const G4TouchableHandle &apValue)
G4double GetGlobalTime() const
G4Material * GetMaterial() const
G4ParticleDefinition * GetDefinition() const
const G4DynamicParticle * GetDynamicParticle() const
const G4TouchableHandle & GetTouchableHandle() const
G4double GetKineticEnergy() const
void SetCreatorModelID(const G4int id)
G4int GetParentID() const
const G4MaterialCutsCouple * GetMaterialCutsCouple() const
static G4TransportationManager * GetTransportationManager()
G4SafetyHelper * GetSafetyHelper() const
G4VContinuousDiscreteProcess(const G4String &, G4ProcessType aType=fNotDefined)
virtual G4double Dispersion(const G4Material *, const G4DynamicParticle *, const G4double tcut, const G4double tmax, const G4double length)=0
virtual G4double SampleFluctuations(const G4MaterialCutsCouple *, const G4DynamicParticle *, const G4double tcut, const G4double tmax, const G4double length, const G4double meanLoss)=0
void SetParticleChange(G4VParticleChange *, G4VEmFluctuationModel *f=nullptr)
void AddEmModel(G4int, G4VEmModel *, G4VEmFluctuationModel *fluc=nullptr, const G4Region *region=nullptr)
G4double GetContinuousStepLimit(const G4Track &track, G4double previousStepSize, G4double currentMinimumStep, G4double ¤tSafety) override
void SetMaxKinEnergy(G4double e)
G4ParticleChangeForLoss fParticleChange
void PreparePhysicsTable(const G4ParticleDefinition &) override
G4double MeanFreePath(const G4Track &track)
virtual void InitialiseEnergyLossProcess(const G4ParticleDefinition *, const G4ParticleDefinition *)=0
void SelectModel(G4double kinEnergy)
void SetRangeTableForLoss(G4PhysicsTable *p)
G4PhysicsVector * LambdaPhysicsVector(const G4MaterialCutsCouple *, G4double cut)
void ProcessDescription(std::ostream &outFile) const override
G4PhysicsTable * BuildDEDXTable(G4EmTableType tType=fRestricted)
void SetTwoPeaksXS(std::vector< G4TwoPeaksXS * > *)
const G4MaterialCutsCouple * currentCouple
virtual G4double MinPrimaryEnergy(const G4ParticleDefinition *, const G4Material *, G4double cut)
G4double preStepScaledEnergy
void ActivateSecondaryBiasing(const G4String ®ion, G4double factor, G4double energyLimit)
G4double PostStepGetPhysicalInteractionLength(const G4Track &track, G4double previousStepSize, G4ForceCondition *condition) override
const G4Element * GetCurrentElement() const
void SetDEDXBinning(G4int nbins)
void SetStepFunction(G4double v1, G4double v2)
void SetEmModel(G4VEmModel *, G4int index=0)
void SetCrossSectionBiasingFactor(G4double f, G4bool flag=true)
const G4Material * currentMaterial
G4double GetMeanFreePath(const G4Track &track, G4double previousStepSize, G4ForceCondition *condition) override
G4double ContinuousStepLimit(const G4Track &track, G4double previousStepSize, G4double currentMinimumStep, G4double ¤tSafety)
void SetInverseRangeTable(G4PhysicsTable *p)
G4bool RetrievePhysicsTable(const G4ParticleDefinition *, const G4String &directory, G4bool ascii) override
void ActivateForcedInteraction(G4double length, const G4String ®ion, G4bool flag=true)
void SetDynamicMassCharge(G4double massratio, G4double charge2ratio)
void SetEnergyOfCrossSectionMax(std::vector< G4double > *)
G4double CrossSectionPerVolume(G4double kineticEnergy, const G4MaterialCutsCouple *couple)
void SetDEDXTable(G4PhysicsTable *p, G4EmTableType tType)
G4PhysicsTable * BuildLambdaTable(G4EmTableType tType=fRestricted)
G4bool StorePhysicsTable(const G4ParticleDefinition *, const G4String &directory, G4bool ascii=false) override
~G4VEnergyLossProcess() override
void SetIonisation(G4bool val)
G4double AlongStepGetPhysicalInteractionLength(const G4Track &, G4double previousStepSize, G4double currentMinimumStep, G4double ¤tSafety, G4GPILSelection *selection) override
void SetLinearLossLimit(G4double val)
void SetLowestEnergyLimit(G4double)
void SetLambdaTable(G4PhysicsTable *p)
void BuildPhysicsTable(const G4ParticleDefinition &) override
G4VEnergyLossProcess(const G4String &name="EnergyLoss", G4ProcessType type=fElectromagnetic)
G4double preStepKinEnergy
G4VParticleChange * AlongStepDoIt(const G4Track &, const G4Step &) override
G4double GetDEDXDispersion(const G4MaterialCutsCouple *couple, const G4DynamicParticle *dp, G4double length)
void ActivateSubCutoff(const G4Region *region)
void SetCSDARangeTable(G4PhysicsTable *pRange)
std::size_t currentCoupleIndex
virtual void StreamProcessInfo(std::ostream &) const
G4VParticleChange * PostStepDoIt(const G4Track &, const G4Step &) override
void StartTracking(G4Track *) override
void SetMinKinEnergy(G4double e)
G4LogicalVolume * GetLogicalVolume() const
G4double currentInteractionLength
G4double theInitialNumberOfInteractionLength
void SetVerboseLevel(G4int value)
const G4VProcess * GetMasterProcess() const
G4double theNumberOfInteractionLengthLeft
G4VParticleChange * pParticleChange
G4int GetProcessSubType() const
const G4String & GetProcessName() const