53 (fMapBendingAngle.count(crystalID) > 0)
58 (fMapMiscutAngle.count(crystalID) > 0)
64 (fMapCUAmplitudePeriodPhase.count(crystalID) > 0)
77 fMapBendingAngle[crystalID]=tetab;
95 G4cout <<
"Warning: bending angle is lower than 1 urad => set to 0" <<
G4endl;
118 G4cout <<
"Warning: bending angle is negative => set to be positive" <<
G4endl;
132 fMapMiscutAngle[crystalID]=tetam;
136 if (std::abs(tetam)>1.*mrad)
139 G4cout <<
"Warning: miscut angle is higher than 1 mrad => " <<
G4endl;
140 G4cout <<
"coordinate transformation routines may be unstable" <<
G4endl;
160 G4cout <<
"Warning: The crystalline undulator parameters are out of range "
161 "=> the crystalline undulator mode switched off" <<
G4endl;
176 fMapCUAmplitudePeriodPhase[crystalID]=amplitudePeriodPhase;
178 G4double period = amplitudePeriodPhase.
y();
187 fCUK = CLHEP::twopi/period;
195 G4cout <<
"Warning: crystalline undulator is not compatible with "
196 "a bent crystal mode => setting bending angle to 0." <<
G4endl;
205 fMapCUAmplitudePeriodPhase[crystalID] =
G4ThreeVector(0.,0.,0.);
222 fParticleName=particleName;
229 fTetaL = std::sqrt(std::abs(fZ2)*
fVmax2/fPV);
234 fGamma = etotal/mass;
235 fMe2Gamma = 2*CLHEP::electron_mass_c2*fGamma;
237 fTmax = fMe2Gamma*fGamma*fV2/
238 (CLHEP::electron_mass_c2/mass*CLHEP::electron_mass_c2/mass +
239 1. + fMe2Gamma/mass);
241 if(fParticleName==
"e-"){fTmax/=2;}
286 G4double pv0 = etotal-mass*mass/etotal;
287 return std::sqrt(2*std::abs(charge)*
fVmax/pv0);
307 angle = std::abs(tx);
311 angle = std::sqrt(tx*tx+ty*ty);
317 simulationstep = fChannelingStep;
322 if (angle > 0.0) { simulationstep /= angle; }
325 return simulationstep;
362 if (teta122<=
fTeta12[ielement]*1.000125)
369 teta22=teta122-
fTeta12[ielement];
375 (1.-std::exp(-aa*
fBB[ielement]))/aa1+
377 (expint(
fBB[ielement]*aa1)-
fE1XBbb[ielement]));
385 t=std::sqrt(-tetamsi*
G4Log(ksi));
389 tx+=t*std::cos(CLHEP::twopi*ksi);
390 ty+=t*std::sin(CLHEP::twopi*ksi);
433 tx+=t*std::cos(CLHEP::twopi*ksi);
434 ty+=t*std::sin(CLHEP::twopi*ksi);
466 if (eMinIonization<0.5*eV){eMinIonization=0.5*eV;}
469 if ((eMinIonization<fTmax)&&(electronDensity>
DBL_EPSILON))
476 zss=-1.0*
G4Log(ksi)/(
fK3*electronDensity)/(1./eMinIonization-1./fTmax);
486 G4double e1=eMinIonization/(1.-ksi*(1.-eMinIonization/fTmax));
492 t=std::sqrt(2.*CLHEP::electron_mass_c2*e1*(1-e1/fTmax))/fPz;
499 tx+=t*std::cos(CLHEP::twopi*ksi);
500 ty+=t*std::sin(CLHEP::twopi*ksi);
508 zss=-1.0*
G4Log(ksi)/(
fK3*electronDensity)/(1./eMinIonization-1./fTmax);
527 if(delta<0){delta=0;}
529 if(fParticleName==
"e-")
531 loge+=(-
G4Log(2.) + 1
532 -(2*fGamma - 1)/fGamma/fGamma*
G4Log(2.) +
533 1/8*((fGamma - 1)/fGamma)*((fGamma - 1)/fGamma));
535 else if(fParticleName==
"e+")
537 loge+=(-fV2/12*(11 + 14/(fGamma + 1) + 10/(fGamma + 1)/(fGamma + 1) +
538 4/(fGamma + 1)/(fGamma + 1)/(fGamma + 1)));
544 elosses=fZ2*fZ2*
fKD[ielement]/fV2*loge*dz;
571 for(
int K=1; K<=25; K++)
573 R=-R*K*X/std::pow(K+1.,2.);
575 if (std::abs(R)<=std::abs(E1)*1.0e-15) {
break;}
578 E1=-0.5772156649015328-
G4Log(X)+X*E1;
582 M=20+std::trunc(80.0/X);
585 for(
int K=
M; K>=1; K--)
G4double G4Log(G4double x)
CLHEP::Hep3Vector G4ThreeVector
Definition of the G4VChannelingFastSimCrystalData class The class contains the data and properties re...
G4GLOB_DLL std::ostream G4cout
G4VSolid * GetSolid() const
G4int GetInstanceID() const
const G4String & GetName() const
std::vector< G4double > fBB
std::vector< G4double > fI0
std::vector< G4double > fTeta12
G4double IonizationLosses(G4double dz, G4int ielement)
ionization losses
std::vector< G4double > fK20
coefficients necessary for multiple and single coulomb scattering
G4double GetLindhardAngle()
Calculate the value of the Lindhard angle (!!! the value for a straight crystal)
void SetGeometryParameters(const G4LogicalVolume *crystallogic)
set geometry parameters from current logical volume
std::vector< G4double > fK40
void SetCUParameters(const G4ThreeVector &litudePeriodPhase, const G4LogicalVolume *crystallogic)
G4double GetMaxSimulationStep(G4double etotal, G4double mass, G4double charge)
Calculate maximal simulation step (standard value for channeling particles)
std::vector< G4double > fPzu11
std::vector< G4double > fBBDEXP
std::vector< G4double > fLogPlasmaEdI0
void SetCrystallineUndulatorParameters(G4double amplitude, G4double period, G4double phase, const G4LogicalVolume *crystallogic)
G4ThreeVector fHalfDimBoundingBox
values related to the crystal geometry
G4double GetSimulationStep(G4double tx, G4double ty)
void SetBendingAngle(G4double tetab, const G4LogicalVolume *crystallogic)
std::vector< G4double > fKD
std::vector< G4double > fTetamax0
G4VChannelingFastSimCrystalData()
G4int fNelements
values related to the crystal lattice
G4ThreeVector CoulombElectronScattering(G4double eMinIonization, G4double electronDensity, G4double step)
multiple and single scattering on electrons
std::vector< G4double > fTeta10
angles necessary for multiple and single coulomb scattering
std::vector< G4double > fTetamax12
std::vector< G4double > fPu11
coefficients for multiple scattering suppression
G4ThreeVector CoulombAtomicScattering(G4double effectiveStep, G4double step, G4int ielement)
multiple and single scattering on screened potential
std::vector< G4double > fE1XBbb
std::vector< G4double > fTetamax2
std::vector< G4double > fK2
virtual ~G4VChannelingFastSimCrystalData()
void SetMiscutAngle(G4double tetam, const G4LogicalVolume *crystallogic)
void SetParticleProperties(G4double etotal, G4double mp, G4double charge, const G4String &particleName)
virtual void BoundingLimits(G4ThreeVector &pMin, G4ThreeVector &pMax) const