|
| G4WentzelVIModel (const G4String &nam="WentzelVIUni") |
|
virtual | ~G4WentzelVIModel () |
|
virtual void | Initialise (const G4ParticleDefinition *, const G4DataVector &) |
|
void | StartTracking (G4Track *) |
|
virtual G4double | ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double KineticEnergy, G4double AtomicNumber, G4double AtomicWeight=0., G4double cut=DBL_MAX, G4double emax=DBL_MAX) |
|
virtual G4ThreeVector & | SampleScattering (const G4ThreeVector &, G4double safety) |
|
virtual G4double | ComputeTruePathLengthLimit (const G4Track &track, G4double ¤tMinimalStep) |
|
virtual G4double | ComputeGeomPathLength (G4double truePathLength) |
|
virtual G4double | ComputeTrueStepLength (G4double geomStepLength) |
|
void | SetFixedCut (G4double) |
|
G4double | GetFixedCut () const |
|
G4WentzelOKandVIxSection * | GetWVICrossSection () |
|
| G4VMscModel (const G4String &nam) |
|
virtual | ~G4VMscModel () |
|
virtual void | SampleSecondaries (std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double tmax) |
|
void | SetStepLimitType (G4MscStepLimitType) |
|
void | SetLateralDisplasmentFlag (G4bool val) |
|
void | SetRangeFactor (G4double) |
|
void | SetGeomFactor (G4double) |
|
void | SetSkin (G4double) |
|
void | SetSampleZ (G4bool) |
|
G4VEnergyLossProcess * | GetIonisation () const |
|
void | SetIonisation (G4VEnergyLossProcess *, const G4ParticleDefinition *part) |
|
G4double | ComputeSafety (const G4ThreeVector &position, G4double limit) |
|
G4double | ComputeGeomLimit (const G4Track &, G4double &presafety, G4double limit) |
|
G4double | GetDEDX (const G4ParticleDefinition *part, G4double kineticEnergy, const G4MaterialCutsCouple *couple) |
|
G4double | GetRange (const G4ParticleDefinition *part, G4double kineticEnergy, const G4MaterialCutsCouple *couple) |
|
G4double | GetEnergy (const G4ParticleDefinition *part, G4double range, const G4MaterialCutsCouple *couple) |
|
G4double | GetTransportMeanFreePath (const G4ParticleDefinition *part, G4double kinEnergy) |
|
| G4VEmModel (const G4String &nam) |
|
virtual | ~G4VEmModel () |
|
virtual void | InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel) |
|
virtual void | InitialiseForMaterial (const G4ParticleDefinition *, const G4Material *) |
|
virtual void | InitialiseForElement (const G4ParticleDefinition *, G4int Z) |
|
virtual G4double | ComputeDEDXPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=DBL_MAX) |
|
virtual G4double | CrossSectionPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX) |
|
virtual G4double | ChargeSquareRatio (const G4Track &) |
|
virtual G4double | GetChargeSquareRatio (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy) |
|
virtual G4double | GetParticleCharge (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy) |
|
virtual void | CorrectionsAlongStep (const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double &eloss, G4double &niel, G4double length) |
|
virtual G4double | Value (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy) |
|
virtual G4double | MinPrimaryEnergy (const G4Material *, const G4ParticleDefinition *, G4double cut=0.0) |
|
virtual G4double | MinEnergyCut (const G4ParticleDefinition *, const G4MaterialCutsCouple *) |
|
virtual void | SetupForMaterial (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy) |
|
virtual void | DefineForRegion (const G4Region *) |
|
void | InitialiseElementSelectors (const G4ParticleDefinition *, const G4DataVector &) |
|
std::vector
< G4EmElementSelector * > * | GetElementSelectors () |
|
void | SetElementSelectors (std::vector< G4EmElementSelector * > *) |
|
G4double | ComputeDEDX (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=DBL_MAX) |
|
G4double | CrossSection (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX) |
|
G4double | ComputeMeanFreePath (const G4ParticleDefinition *, G4double kineticEnergy, const G4Material *, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX) |
|
G4double | ComputeCrossSectionPerAtom (const G4ParticleDefinition *, const G4Element *, G4double kinEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX) |
|
G4int | SelectIsotopeNumber (const G4Element *) |
|
const G4Element * | SelectRandomAtom (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX) |
|
const G4Element * | SelectRandomAtom (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX) |
|
G4int | SelectRandomAtomNumber (const G4Material *) |
|
void | SetParticleChange (G4VParticleChange *, G4VEmFluctuationModel *f=0) |
|
void | SetCrossSectionTable (G4PhysicsTable *, G4bool isLocal) |
|
G4ElementData * | GetElementData () |
|
G4PhysicsTable * | GetCrossSectionTable () |
|
G4VEmFluctuationModel * | GetModelOfFluctuations () |
|
G4VEmAngularDistribution * | GetAngularDistribution () |
|
void | SetAngularDistribution (G4VEmAngularDistribution *) |
|
G4double | HighEnergyLimit () const |
|
G4double | LowEnergyLimit () const |
|
G4double | HighEnergyActivationLimit () const |
|
G4double | LowEnergyActivationLimit () const |
|
G4double | PolarAngleLimit () const |
|
G4double | SecondaryThreshold () const |
|
G4bool | LPMFlag () const |
|
G4bool | DeexcitationFlag () const |
|
G4bool | ForceBuildTableFlag () const |
|
G4bool | UseAngularGeneratorFlag () const |
|
void | SetAngularGeneratorFlag (G4bool) |
|
void | SetHighEnergyLimit (G4double) |
|
void | SetLowEnergyLimit (G4double) |
|
void | SetActivationHighEnergyLimit (G4double) |
|
void | SetActivationLowEnergyLimit (G4double) |
|
G4bool | IsActive (G4double kinEnergy) |
|
void | SetPolarAngleLimit (G4double) |
|
void | SetSecondaryThreshold (G4double) |
|
void | SetLPMFlag (G4bool val) |
|
void | SetDeexcitationFlag (G4bool val) |
|
void | SetForceBuildTable (G4bool val) |
|
void | SetMasterThread (G4bool val) |
|
G4bool | IsMaster () const |
|
G4double | MaxSecondaryKinEnergy (const G4DynamicParticle *dynParticle) |
|
const G4String & | GetName () const |
|
void | SetCurrentCouple (const G4MaterialCutsCouple *) |
|
const G4Element * | GetCurrentElement () const |
|
Definition at line 69 of file G4WentzelVIModel.hh.
Reimplemented from G4VMscModel.
Definition at line 176 of file G4WentzelVIModel.cc.
References G4VMscModel::ComputeGeomLimit(), G4VMscModel::ComputeSafety(), G4VMscModel::ConvertTrueToGeom(), G4VMscModel::facgeom, G4VMscModel::facrange, G4VMscModel::facsafety, fGeomBoundary, fUseDistanceToBoundary, G4Track::GetDynamicParticle(), G4DynamicParticle::GetKineticEnergy(), G4Track::GetMaterialCutsCouple(), G4StepPoint::GetPosition(), G4Step::GetPreStepPoint(), G4ProductionCuts::GetProductionCut(), G4MaterialCutsCouple::GetProductionCuts(), G4Material::GetRadlen(), G4VMscModel::GetRange(), G4StepPoint::GetSafety(), G4Track::GetStep(), G4StepPoint::GetStepStatus(), G4VMscModel::GetTransportMeanFreePath(), G4INCL::Math::max(), G4INCL::Math::min(), G4WentzelOKandVIxSection::SetupKinematic(), G4InuclParticleNames::sp, and G4VMscModel::steppingAlgorithm.
180 G4double tlimit = currentMinimalStep;
184 singleScatteringMode =
false;
193 currentRange =
GetRange(particle,preKinEnergy,currentCouple);
194 cosTetMaxNuc = wokvi->
SetupKinematic(preKinEnergy, currentMaterial);
201 if(tlimit > currentRange) { tlimit = currentRange; }
204 if(inside || tlimit < tlimitminfix) {
211 if(currentRange < presafety) {
218 if(stepStatus !=
fGeomBoundary && presafety < tlimitminfix) {
220 if(currentRange < presafety) {
236 0.7*(1.0 - cosTetMaxNuc)*lambdaeff);
239 if(cosThetaMax > cosTetMaxNuc) {
248 if(rcut > rlimit) { rlimit =
std::min(rlimit, rcut*sqrt(rlimit/rcut)); }
250 if(rlimit < tlimit) { tlimit = rlimit; }
252 tlimit =
std::max(tlimit, tlimitminfix);
G4double GetKineticEnergy() const
const G4DynamicParticle * GetDynamicParticle() const
G4double GetProductionCut(G4int index) const
G4StepStatus GetStepStatus() const
G4double ConvertTrueToGeom(G4double &tLength, G4double &gLength)
const G4MaterialCutsCouple * GetMaterialCutsCouple() const
const G4Step * GetStep() const
G4StepPoint * GetPreStepPoint() const
const G4ThreeVector & GetPosition() const
G4double GetRange(const G4ParticleDefinition *part, G4double kineticEnergy, const G4MaterialCutsCouple *couple)
G4double SetupKinematic(G4double kinEnergy, const G4Material *mat)
G4double ComputeGeomLimit(const G4Track &, G4double &presafety, G4double limit)
G4double GetTransportMeanFreePath(const G4ParticleDefinition *part, G4double kinEnergy)
G4double GetRadlen() const
G4double ComputeSafety(const G4ThreeVector &position, G4double limit)
T max(const T t1, const T t2)
brief Return the largest of the two arguments
T min(const T t1, const T t2)
brief Return the smallest of the two arguments
G4double GetSafety() const
G4MscStepLimitType steppingAlgorithm
G4ProductionCuts * GetProductionCuts() const
Reimplemented from G4VMscModel.
Definition at line 404 of file G4WentzelVIModel.cc.
References DBL_MAX, G4VMscModel::fDisplacement, G4Exp(), G4Log(), G4lrint(), G4UniformRand, G4Material::GetElementVector(), G4Material::GetNumberOfElements(), G4VMscModel::latDisplasment, G4ParticleChangeForMSC::ProposeMomentumDirection(), CLHEP::Hep3Vector::rotateUz(), G4WentzelOKandVIxSection::SampleSingleScattering(), CLHEP::Hep3Vector::set(), G4WentzelOKandVIxSection::SetupTarget(), G4INCL::DeJongSpin::shoot(), python.hepunit::twopi, z, and G4InuclParticleNames::z0.
412 if(preKinEnergy < lowEnergyLimit || tPathLength <= 0.0)
416 if(lambdaeff <
DBL_MAX) { invlambda = 0.5/lambdaeff; }
419 G4double cut = (*currentCuts)[currentMaterialIndex];
420 if(fixedCut > 0.0) { cut = fixedCut; }
436 if(!singleScatteringMode) {
438 if(z0 > zzmin && safety > tlimitminfix) {
443 if(z0 > zzmin) { zzz =
G4Exp(-1.0/z0); }
451 if(singleScatteringMode && x1 > tPathLength)
468 G4double mscfac = zPathLength/tPathLength;
483 if(singleScatteringMode && x1 > x2) {
break; }
505 for (; i<nelm; ++i) {
if(xsecn[i] >= qsec) {
break; } }
532 if(cost > 1.0) { cost = 1.0; }
533 else if(cost < -1.0) { cost =-1.0; }
534 sint = sqrt((1.0 - cost)*(1.0 + cost));
540 temp.set(vx1,vy1,cost);
546 G4double rms = invsqrt12*sqrt(2*z0);
562 }
while (0 < nMscSteps);
void set(double x, double y, double z)
ThreeVector shoot(const G4int Ap, const G4int Af)
std::vector< G4Element * > G4ElementVector
G4ThreeVector SampleSingleScattering(G4double CosThetaMin, G4double CosThetaMax, G4double elecRatio=0.0)
const G4ElementVector * GetElementVector() const
G4double SetupTarget(G4int Z, G4double cut=DBL_MAX)
Hep3Vector & rotateUz(const Hep3Vector &)
G4ThreeVector fDisplacement
G4double G4Log(G4double x)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
void ProposeMomentumDirection(const G4ThreeVector &Pfinal)
size_t GetNumberOfElements() const