함수 | |
gStyle | SetOptStat (0000) |
gStyle | SetOptFit () |
gStyle | SetPalette (1) |
gROOT | SetStyle ("Plain") |
c1 | Divide (4, 3) |
while (1) | |
fclose (fp) | |
c1 | cd (1) |
h1 | Draw () |
h1 | GetXaxis () -> SetLabelSize(0.025) |
h1 | GetYaxis () -> SetLabelSize(0.025) |
h1 | SetLineColor (3) |
h1 | SetFillColor (3) |
h11 | SetLineColor (8) |
h11 | SetFillColor (8) |
h11 | Draw ("same") |
c1 | cd (5) |
h2 | SetLineColor (2) |
h2 | SetFillColor (2) |
h20 | SetLineColor (5) |
h20 | SetFillColor (5) |
c1 | cd (7) |
ntupleYX | Draw ("Y:X>>hist","vox","colz") |
gPad | SetLogz () |
hist | Draw ("colz") |
hist | GetZaxis () -> SetLabelSize(0.025) |
hist | SetTitle ("Cytoplasm intensity on transverse section") |
c1 | cd (3) |
ntupleYXN | Draw ("Y:X>>hist2","vox","colz") |
hist2 | SetTitle ("Nucleus intensity on transverse section") |
system ("rm -rf microbeam.root") | |
system ("hadd -O microbeam.root microbeam_*.root") | |
TFile | f ("microbeam.root") |
c1 | cd (2) |
ntuple3 | Project ("h1bis","doseN") |
h1bis | Scale (scale) |
c1 | cd (6) |
ntuple3 | Project ("h10bis","doseC") |
c1 | cd (9) |
ntuple0 | Project ("h2bis","sp") |
h2bis | SetTitle ("dE/dx at cell entrance") |
h2bis | SetFillColor (4) |
h2bis | SetLineColor (4) |
h2bis | Fit ("gaus") |
gaus | SetLineColor (6) |
ntuple2 | SetBranchAddress ("x",&x) |
ntuple2 | SetBranchAddress ("y",&y) |
ntuple2 | SetBranchAddress ("z",&z) |
for (Int_t i=0;i< nentries;i++) | |
c1 | cd (10) |
ntupleR | Draw ("X2:Z2","abs(X2)<50","surf3") |
c1 | cd (11) |
ntuple4 | Draw ("y*0.359060:x*0.359060>>histbis","doseV","contz") |
histbis | Draw ("contz") |
histbis | SetTitle ("Energy deposit -transverse- (z axis in eV)") |
c1 | cd (12) |
ntuple4 | Draw ("x*0.359060:(z+1500/0.162810+21)*0.162810>>histter","doseV","contz") |
histter | SetTitle ("Energy deposit -longitudinal- (z axis in eV)") |
c1 | cd (4) |
ntuple1 | Project ("hx","x") |
h77 | SetTitle ("Beam X position on cell") |
c1 | cd (8) |
ntuple1 | Project ("hy","y") |
h88 | SetTitle ("Beam Y position on cell") |
변수 | |
Double_t | scale = 1/h1bis->Integral() |
c1 = new TCanvas ("c1","",20,20,1200,900) | |
FILE * | fp = fopen("phantom.dat","r") |
Float_t | xVox |
Float_t | yVox |
Float_t | zVox |
Float_t | tmp |
Float_t | den |
Float_t | dose |
Float_t | X |
Float_t | Y |
Float_t | Z |
Float_t | vox = 0 |
Float_t | mat = 0 |
Float_t | voxelSizeX |
Float_t | voxelSizeY |
Float_t | voxelSizeZ |
TH1F * | h1 = new TH1F("h1","Nucleus marker intensity",100,1,300) |
TH1F * | h11 = new TH1F("h11 ","",100,1,300) |
TH1F * | h2 = new TH1F("h2","Cytoplasm marker intensity",100,1,300) |
TH1F * | h20 = new TH1F("h20 ","",100,1,300) |
TNtuple * | ntupleYXN = new TNtuple("NUCLEUS","ntuple","Y:X:vox") |
TNtuple * | ntupleZX = new TNtuple("CYTOPLASM","ntuple","Z:X:vox") |
TNtuple * | ntupleYX = new TNtuple("CYTOPLASM","ntuple","Y:X:vox") |
Int_t | nlines =0 |
Int_t | ncols =0 |
TH2F * | hist = new TH2F("hist","hist",50,-20,20,50,-20,20) |
TH2F * | hist2 = new TH2F("hist2","hist2",50,-20,20,50,-20,20) |
TNtuple * | ntuple0 = (TNtuple*)f.Get("ntuple0") |
TNtuple * | ntuple1 = (TNtuple*)f.Get("ntuple1") |
TNtuple * | ntuple2 = (TNtuple*)f.Get("ntuple2") |
TNtuple * | ntuple3 = (TNtuple*)f.Get("ntuple3") |
TNtuple * | ntuple4 = (TNtuple*)f.Get("ntuple4") |
TH1F * | h1bis = new TH1F("h1bis","Dose distribution in Nucleus",100,0.001,1.) |
TH1F * | h10 = new TH1F("h10bis","Dose distribution in Cytoplasm",100,0.001,.2) |
Float_t | d |
TH1F * | h2bis = new TH1F("h2bis","Beam stopping power at cell entrance",200,0,300) |
Double_t | Xc = -1295.59e3 - 955e3*sin(10*TMath::Pi()/180) |
Double_t | Zc = -1327e3 + 955e3*cos(10*TMath::Pi()/180) |
Double_t | X1 |
Double_t | Y1 |
Double_t | Z1 |
Double_t | X2 |
Double_t | Y2 |
Double_t | Z2 |
TNtuple * | ntupleR = new TNtuple("Rmax","ntuple","Z2:Y2:X2") |
Double_t | x |
Double_t | y |
Double_t | z |
Double_t | xx |
Double_t | zz |
Int_t | nentries = (Int_t)ntuple2->GetEntries() |
TH2F * | histbis = new TH2F("histbis","histbis",50,-20,20,50,-20,20) |
TH2F * | histter = new TH2F("histter","histter",50,-20,20,50,-20,20) |
TH1F * | h77 = new TH1F("hx","h1",200,-10,10) |
TH1F * | h88 = new TH1F("hy","h1",200,-10,10) |
c1 cd | ( | 1 | ) |
c1 cd | ( | 5 | ) |
c1 cd | ( | 7 | ) |
c1 cd | ( | 3 | ) |
c1 cd | ( | 2 | ) |
c1 cd | ( | 6 | ) |
c1 cd | ( | 9 | ) |
c1 cd | ( | 10 | ) |
c1 cd | ( | 11 | ) |
c1 cd | ( | 12 | ) |
c1 cd | ( | 4 | ) |
c1 cd | ( | 8 | ) |
c1 Divide | ( | 4 | , |
3 | |||
) |
h1 Draw | ( | ) |
h11 Draw | ( | "same" | ) |
hist2 Draw | ( | "colz" | ) |
ntupleR Draw | ( | "X2:Z2" | ) |
histter Draw | ( | "contz" | ) |
TFile f | ( | "microbeam.root" | ) |
fclose | ( | fp | ) |
h88 Fit | ( | "gaus" | ) |
h1 GetXaxis | ( | ) | -> SetLabelSize(0.025) |
h1 GetYaxis | ( | ) | -> SetLabelSize(0.025) |
histter GetZaxis | ( | ) | -> SetLabelSize(0.025) |
ntuple3 Project | ( | "h1bis" | , |
"doseN" | |||
) |
ntuple3 Project | ( | "h10bis" | , |
"doseC" | |||
) |
ntuple0 Project | ( | "h2bis" | , |
"sp" | |||
) |
ntuple1 Project | ( | "hx" | , |
"x" | |||
) |
ntuple1 Project | ( | "hy" | , |
"y" | |||
) |
ntuple2 SetBranchAddress | ( | "x" | , |
& | x | ||
) |
ntuple2 SetBranchAddress | ( | "y" | , |
& | y | ||
) |
ntuple2 SetBranchAddress | ( | "z" | , |
& | z | ||
) |
h1bis SetFillColor | ( | 3 | ) |
h11 SetFillColor | ( | 8 | ) |
h10 SetFillColor | ( | 2 | ) |
h20 SetFillColor | ( | 5 | ) |
h88 SetFillColor | ( | 4 | ) |
h1bis SetLineColor | ( | 3 | ) |
h11 SetLineColor | ( | 8 | ) |
h2 SetLineColor | ( | 2 | ) |
h20 SetLineColor | ( | 5 | ) |
h88 SetLineColor | ( | 4 | ) |
gaus SetLineColor | ( | 6 | ) |
gPad SetLogz | ( | ) |
gStyle SetOptFit | ( | ) |
gStyle SetOptStat | ( | 0000 | ) |
gStyle SetPalette | ( | 1 | ) |
gROOT SetStyle | ( | "Plain" | ) |
hist SetTitle | ( | "Cytoplasm intensity on transverse section" | ) |
hist2 SetTitle | ( | "Nucleus intensity on transverse section" | ) |
h2bis SetTitle | ( | "dE/dx at cell entrance" | ) |
system | ( | "rm -rf microbeam.root" | ) |
다음에 의해서 참조됨 : G4VRML1FileSceneHandler::closePort(), G4VRML2FileSceneHandler::closePort(), G4GeometryManager::ReportVoxelStats(), G4VisCommandDrawTree::SetNewValue(), G4InteractorMessenger::SetNewValue(), G4UIcontrolMessenger::SetNewValue(), G4RunManager::SetRandomNumberStoreDir(), CexmcRunManager::SetupConstructionHook(), G4FileUtilities::Shell(), G4DAWNFILEViewer::ShowView().
system | ( | "hadd -O microbeam.root microbeam_*.root" | ) |
while | ( | 1 | ) |
advanced/microbeam/plot.C 파일의 55 번째 라인에서 정의되었습니다.
다음을 참조함 : mat, voxelSizeX, voxelSizeY, voxelSizeZ.
c1 = new TCanvas ("c1","",20,20,1200,900) |
advanced/microbeam/plot.C 파일의 28 번째 라인에서 정의되었습니다.
Float_t d |
advanced/microbeam/plot.C 파일의 236 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : MyGamma::Abs(), Run::AddSecondaryTrack(), G4ForwardXrayTR::AngleDensity(), G4Trap::ApproxSurfaceNormal(), G4ErrorSymMatrix::assign(), G4FissionBarrier::BarashenkovFissionBarrier(), G4AnalyticalPolSolver::BiquadRoots(), G4Voxelizer::BuildBitmasks(), G4hhElastic::CalculateBQ(), G4ViewParameters::CatmullRomCubicSplineInterpolation(), G4SynchrotronRadiation::Chebyshev(), G4BinaryCascade::CheckPauliPrinciple(), G4GeomTools::ClosestPointOnTriangle(), MyMollerBhabhaModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4UrbanMscModel::ComputeTheta0(), G4UrbanAdjointMscModel::ComputeTheta0(), CML2Ph_BoxInBox::Construct(), CLHEP::MixMaxRng::convert1double(), G4BoundingEnvelope::CreateListOfPlanes(), G4GenericPolycone::CreatePolyhedron(), G4Polyhedra::CreatePolyhedron(), G4VSceneHandler::CreateSectionSolid(), G4Voxelizer::CreateSortedBoundary(), G4AdjointCrossSurfChecker::CrossingASphere(), G4ChipsAntiBaryonInelasticXS::CrossSectionFormula(), G4ChipsProtonInelasticXS::CrossSectionFormula(), G4ChipsKaonMinusInelasticXS::CrossSectionFormula(), G4ChipsHyperonInelasticXS::CrossSectionFormula(), G4ChipsPionMinusInelasticXS::CrossSectionFormula(), G4ChipsKaonPlusInelasticXS::CrossSectionFormula(), G4ChipsNeutronInelasticXS::CrossSectionFormula(), G4ChipsPionPlusInelasticXS::CrossSectionFormula(), csz__Inflate_codes(), G4AnalyticalPolSolver::CubicRoots(), CLHEP::DoubConv::d2x(), G4HumanPhantomMaterial::DefineMaterials(), BrachyMaterial::DefineMaterials(), G4PhysicalVolumeModel::DescribeAndDescend(), G4TriangularFacet::Distance(), CLHEP::HepAxisAngle::distance(), CLHEP::HepEulerAngles::distance(), G4VTwistSurface::DistanceToBoundary(), G4CutTubs::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Sphere::DistanceToIn(), G4Trap::DistanceToIn(), G4GenericTrap::DistanceToOut(), G4Cons::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4WorkerRunManager::DoWork(), G4eeCrossSections::DpOm(), G4eeCrossSections::DpPhi(), G4eeCrossSections::DpRho(), CLHEP::DoubConv::dto2longs(), G4Abla::ecoul(), G4PhotoNuclearCrossSection::EquLinearFit(), G4ChipsAntiBaryonInelasticXS::EquLinearFit(), G4ChipsKaonMinusInelasticXS::EquLinearFit(), G4ChipsProtonInelasticXS::EquLinearFit(), G4ChipsHyperonInelasticXS::EquLinearFit(), G4ChipsNeutronInelasticXS::EquLinearFit(), G4ChipsPionMinusInelasticXS::EquLinearFit(), G4ChipsKaonPlusInelasticXS::EquLinearFit(), G4ChipsPionPlusInelasticXS::EquLinearFit(), G4ecpssrBaseKxsModel::ExpIntFunction(), G4ecpssrBaseLixsModel::ExpIntFunction(), G4PolyconeSide::Extent(), G4LivermoreGammaConversionModelRC::fbeta(), G4QuasiElRatios::FetchElTot(), CML2PrimaryGenerationAction::fillParticlesContainer(), G4Abla::fissionDistri(), func1(), G4GenericMessenger::G4GenericMessenger(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), MyGamma::GamCf(), G4Abla::gcf(), CLHEP::RandGamma::genGamma(), G4ParticleHPFFFissionFS::GetAFissionFragment(), G4VTwistSurface::GetBoundaryAtPZ(), G4MultiUnion::GetCubicVolume(), G4VEnergyLossProcess::GetDEDXDispersion(), G4NuclNuclDiffuseElastic::GetErfSer(), G4OpenGLFontBaseStore::GetFontInfo(), G4QuasiElRatios::GetQF2IN_Ratio(), G4PhononDownconversion::GetTTDecayProb(), CLHEP::Hep2Vector::howNear(), CLHEP::Hep3Vector::howNear(), G4PolarizedBhabhaCrossSection::Initialize(), G4Trap::Inside(), G4TriangularFacet::Intersect(), G4VFacet::IsInside(), G4eIonisationParameters::LoadData(), G4RDeIonisationParameters::LoadData(), G4UImanager::Loop(), G4PhononDownconversion::MakeLTSecondaries(), G4PhononDownconversion::MakeTTSecondaries(), max4(), CLHEP::Hep3Vector::negativeInfinity(), nf_exponentialIntegral(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), CML2Acc1::otherMaterials(), G4RDModifiedTsai::PolarAngle(), G4DataInterpolation::PolynomInterpolation(), ptwXY_copyToC_XY(), ptwXY_setXYData(), G4AnalyticalPolSolver::QuadRoots(), G4AnalyticalPolSolver::QuarticRoots(), G4DataInterpolation::RationalPolInterpolation(), G4DCIOcatalog::RegisterDCIOmanager(), G4HCIOcatalog::RegisterEntry(), G4DCIOcatalog::RegisterEntry(), G4HCIOcatalog::RegisterHCIOmanager(), G4Scintillation::sample_time(), G4NeutrinoElectronCcModel::SampleCosCMS(), G4UrbanMscModel::SampleCosineTheta(), G4UrbanAdjointMscModel::SampleCosineTheta(), G4NeutrinoElectronNcModel::SampleElectronTkin(), G4WentzelVIModel::SampleScattering(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4PenelopeSamplingData::SampleValue(), CLHEP::HepLorentzRotation::set(), LaserDrivenBeamLine::SetDefaultDimensions(), Collimator100BeamLine::SetDefaultDimensions(), Collimator60BeamLine::SetDefaultDimensions(), Collimator50BeamLine::SetDefaultDimensions(), Collimator80BeamLine::SetDefaultDimensions(), Collimator40BeamLine::SetDefaultDimensions(), Collimator70BeamLine::SetDefaultDimensions(), PassiveCarbonBeamLine::SetDefaultDimensions(), PassiveProtonBeamLine::SetDefaultDimensions(), G4INCL::ParticleSampler::setDensity(), G4INCL::Nucleus::setDensity(), XBase::SetDVal(), AClass::SetDVal(), G4VTwistSurface::Boundary::SetFields(), G4ILawTruncatedExp::SetMaximumDistance(), G4NavigationLogger::SetMinTriggerDistance(), G4VPrimitiveScorer::SetMultiFunctionalDetector(), G4INCL::Config::setNeutronHalo(), G4INCL::Config::setNeutronSkin(), G4LivermorePolarizedPhotoElectricGDModel::SetPhi(), RMC01DetectorConstruction::SetShieldingThickness(), CCalHit::setTimeSlice(), G4BulirschStoer::should_reject(), G4ElectroNuclearCrossSection::SolveTheEquation(), G4PAIySection::SumOverBordCerenkov(), G4PAIxSection::SumOverBordCerenkov(), G4PAIySection::SumOverBorder(), G4PAIxSection::SumOverBorder(), G4PAIySection::SumOverBorderdEdx(), G4PAIxSection::SumOverBorderdEdx(), G4PAIxSection::SumOverBordMM(), G4PAIySection::SumOverBordPlasmon(), G4PAIxSection::SumOverBordPlasmon(), G4PAIxSection::SumOverBordResonance(), G4Trap::SurfaceNormal(), G4Torus::TorusRootsJT(), G4ErrorMatrix::trace(), HepPolyhedron::Transform(), G4ParticleHPInelasticCompFS::two_body_reaction(), G4Clebsch::WignerLittleD(), cheprep::BHepRepWriter::writeReal().
Float_t den |
advanced/microbeam/plot.C 파일의 36 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4StatMFMacroMultiNucleon::CalcZARatio(), CellParameterisation::CellParameterisation(), G4ScreeningMottCrossSection::FormFactor2ExpHof(), G4PreCompoundFragment::IntegrateEmissionProbability(), G4ScreeningMottCrossSection::SetDifferentialXSection().
Float_t dose |
advanced/microbeam/plot.C 파일의 36 번째 라인에서 정의되었습니다.
FILE* fp = fopen("phantom.dat","r") |
advanced/microbeam/plot.C 파일의 35 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4LEPTSDiffXS::readDXS(), G4LEPTSDistribution::ReadFile(), G4LEPTSElossDistr::ReadFile(), G4BoldyshevTripletModel::SampleSecondaries().
TH1F* h1 = new TH1F("h1","Nucleus marker intensity",100,1,300) |
advanced/microbeam/plot.C 파일의 42 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : AnalyseChannelingEfficiency(), G4Physics2DVector::BicubicInterpolation(), G4OpenInventorXtExaminerViewer::constructListsDialog(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4QuadrangularFacet::G4QuadrangularFacet(), GammaFit(), HistoManager::Normalize(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), HistoManager::PrintStatistic(), G4ErrorFreeTrajState::PropagateError(), readExfor(), G4RootAnalysisReader::ReadH1Impl(), G4Hdf5AnalysisReader::ReadH1Impl(), G4CsvAnalysisReader::ReadH1Impl(), G4XmlAnalysisReader::ReadH1Impl(), G4AtimaEnergyLossModel::sezi_dedx_e(), while(), G4H1ToolsManager::WriteOnAscii().
TH1F* h10 = new TH1F("h10bis","Dose distribution in Cytoplasm",100,0.001,.2) |
advanced/microbeam/plot.C 파일의 188 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4ViewParameters::CatmullRomCubicSplineInterpolation(), G4ErrorSymMatrix::invertCholesky5(), G4ErrorSymMatrix::invertCholesky6().
TH1F* h11 = new TH1F("h11 ","",100,1,300) |
advanced/microbeam/plot.C 파일의 43 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4ViewParameters::CatmullRomCubicSplineInterpolation(), G4ErrorSymMatrix::invertCholesky5(), G4ErrorSymMatrix::invertCholesky6().
TH1F* h1bis = new TH1F("h1bis","Dose distribution in Nucleus",100,0.001,1.) |
advanced/microbeam/plot.C 파일의 187 번째 라인에서 정의되었습니다.
TH1F* h2 = new TH1F("h2","Cytoplasm marker intensity",100,1,300) |
advanced/microbeam/plot.C 파일의 45 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4Physics2DVector::BicubicInterpolation(), G4SPSEneDistribution::CalculateBbodySpectrum(), G4OpenInventorXtExaminerViewer::constructListsDialog(), G4ModifiedMidpoint::DoStep(), for(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), G4QuadrangularFacet::G4QuadrangularFacet(), GammaFit(), G4CrystalUnitCell::GetIntCosAng(), G4CrystalUnitCell::GetIntSp2(), G4CrystalUnitCell::GetRecIntSp2(), G4ErrorFreeTrajState::PropagateError(), G4RootAnalysisReader::ReadH2Impl(), G4Hdf5AnalysisReader::ReadH2Impl(), G4CsvAnalysisReader::ReadH2Impl(), G4XmlAnalysisReader::ReadH2Impl(), G4VisCommandSceneAddLogo::SetNewValue(), while().
TH1F* h20 = new TH1F("h20 ","",100,1,300) |
advanced/microbeam/plot.C 파일의 46 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4ErrorSymMatrix::invertCholesky5(), G4ErrorSymMatrix::invertCholesky6().
TH1F* h2bis = new TH1F("h2bis","Beam stopping power at cell entrance",200,0,300) |
advanced/microbeam/plot.C 파일의 238 번째 라인에서 정의되었습니다.
TH1F* h77 = new TH1F("hx","h1",200,-10,10) |
advanced/microbeam/plot.C 파일의 350 번째 라인에서 정의되었습니다.
TH1F* h88 = new TH1F("hy","h1",200,-10,10) |
advanced/microbeam/plot.C 파일의 351 번째 라인에서 정의되었습니다.
TH2F* hist = new TH2F("hist","hist",50,-20,20,50,-20,20) |
advanced/microbeam/plot.C 파일의 135 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : Par01CalorimeterSD::ProcessHits().
TH2F* hist2 = new TH2F("hist2","hist2",50,-20,20,50,-20,20) |
advanced/microbeam/plot.C 파일의 153 번째 라인에서 정의되었습니다.
TH2F* histbis = new TH2F("histbis","histbis",50,-20,20,50,-20,20) |
advanced/microbeam/plot.C 파일의 310 번째 라인에서 정의되었습니다.
TH2F* histter = new TH2F("histter","histter",50,-20,20,50,-20,20) |
advanced/microbeam/plot.C 파일의 326 번째 라인에서 정의되었습니다.
Float_t mat = 0 |
advanced/microbeam/plot.C 파일의 39 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4PixeCrossSectionHandler::ActiveElements(), CCalMaterialFactory::addCCalMaterial(), G4GMocrenFileSceneHandler::AddSolid(), G4ElectroVDNuclearModel::ApplyYourself(), G4VDNAModel::BuildApplyToMatVect(), G4PixeCrossSectionHandler::BuildCrossSectionsForMaterials(), G4PixeCrossSectionHandler::BuildForMaterials(), G4NistMaterialBuilder::BuildMaterial(), G4DNAModelInterface::BuildMaterialParticleModelTable(), G4NistManager::BuildMaterialWithNewDensity(), G4RDVCrossSectionHandler::BuildMeanFreePathForMaterials(), G4VCrossSectionHandler::BuildMeanFreePathForMaterials(), G4NistMaterialBuilder::BuildNistMaterial(), G4CrossSectionPairGG::BuildPhysicsTable(), G4LossTableBuilder::BuildTableForModel(), G4ElectroVDNuclearModel::CalculateEMVertex(), G4Track::CalculateVelocityForOpticalPhoton(), CCalAMaterial::CCalAMaterial(), CellParameterisation::CellParameterisation(), G4CrossSectionDataStore::ComputeCrossSection(), G4EmCalculator::ComputeDEDXForCutInRange(), G4WentzelVIRelModel::ComputeEffectiveMass(), G4TablesForExtrapolator::ComputeElectronDEDX(), G4VXTRenergyLoss::ComputeGasPhotoAbsCof(), RE02NestedPhantomParameterisation::ComputeMaterial(), G4StrawTubeXTRadiator::ComputeMediumPhotoAbsCof(), G4TablesForExtrapolator::ComputeMuonDEDX(), G4VXTRenergyLoss::ComputePlatePhotoAbsCof(), G4TablesForExtrapolator::ComputeProtonDEDX(), G4TablesForExtrapolator::ComputeTrasportXS(), G4NistMaterialBuilder::ConstructNewGasMaterial(), G4NistMaterialBuilder::ConstructNewIdealGasMaterial(), G4NistMaterialBuilder::ConstructNewMaterial(), G4AtimaEnergyLossModel::CorrectionsAlongStep(), G4BetheBlochModel::CorrectionsAlongStep(), G4BraggIonModel::CorrectionsAlongStep(), G4EmSaturation::DumpBirksCoefficients(), G4tgbGeometryDumper::DumpMaterial(), G4ElectronIonPair::DumpMeanEnergyPerIonPair(), G4EmCorrections::EffectiveChargeCorrection(), HistoManager::EndOfRun(), CCalMaterialFactory::findCCalAMaterial(), CCalMaterialFactory::findCCalMaterial(), CCalMaterialFactory::findElement(), CCalMaterialFactory::findG4Material(), G4NistMaterialBuilder::FindOrBuildMaterial(), G4NistMaterialBuilder::FindOrBuildSimpleMaterial(), G4GDMLWriteDefine::GetAngles(), RE04TrajectoryPoint::GetAttDefs(), G4CrossSectionDataStore::GetCrossSection(), G4ESTARStopping::GetIndex(), F04Materials::GetMaterial(), WLSMaterials::GetMaterial(), XrayFluoNistMaterials::GetMaterial(), G4HadronicProcess::GetMicroscopicCrossSection(), G4GoudsmitSaundersonMscModel::GetTransportMeanFreePath(), G4GoudsmitSaundersonMscModel::GetTransportMeanFreePathOnly(), G4GSPWACorrections::InitDataPerElement(), G4GSPWACorrections::InitDataPerMaterials(), G4LivermoreGammaConversionModel::Initialise(), G4NeutronElectronElXsc::Initialise(), G4ASTARStopping::Initialise(), G4PSTARStopping::Initialise(), G4PAIPhotModel::Initialise(), G4PAIPhotData::Initialise(), G4PAIModelData::Initialise(), G4PAIModel::Initialise(), G4HadronXSDataTable::Initialise(), G4LossTableBuilder::InitialiseBaseMaterials(), G4LossTableBuilder::InitialiseCouples(), G4LivermoreGammaConversionModel::InitialiseProbability(), G4DNAMolecularMaterial::Initialize(), G4SandiaTable::Initialize(), G4GSMottCorrection::InitMCDataPerElement(), G4GSMottCorrection::InitMCDataPerMaterials(), G4ScreenedNuclearRecoil::PostStepDoIt(), pyG4Material::Print(), G4NistManager::PrintG4Material(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4CrossSectionDataStore::SampleZandA(), G4Region::ScanVolumeTree(), G4ElementSelector::SelectZandA(), DetectorConstruction::SetContainerMaterial(), DetectorConstruction::SetGasMaterial(), GFlashHomoShowerParameterisation::SetMaterial(), G4DNASecondOrderReaction::SetReaction(), DetectorConstruction::SetTargetMaterial(), HistoManager::SetTargetMaterial(), G4WentzelVIRelXSection::SetupKinematic(), G4WentzelOKandVIxSection::SetupKinematic(), G4EnergyLossForExtrapolator::SetupKinematics(), G4EmCorrections::SetupKinematics(), G4EmCalculator::SetupMaterial(), DetectorConstruction::SetWorldMaterial(), while().
Int_t ncols =0 |
advanced/microbeam/plot.C 파일의 53 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : CellParameterisation::CellParameterisation().
Int_t nentries = (Int_t)ntuple2->GetEntries() |
advanced/microbeam/plot.C 파일의 281 번째 라인에서 정의되었습니다.
Int_t nlines =0 |
advanced/microbeam/plot.C 파일의 52 번째 라인에서 정의되었습니다.
ntuple0 = (TNtuple*)f.Get("ntuple0") |
advanced/microbeam/plot.C 파일의 175 번째 라인에서 정의되었습니다.
ntuple1 = (TNtuple*)f.Get("ntuple1") |
advanced/microbeam/plot.C 파일의 176 번째 라인에서 정의되었습니다.
ntuple2 = (TNtuple*)f.Get("ntuple2") |
advanced/microbeam/plot.C 파일의 177 번째 라인에서 정의되었습니다.
ntuple3 = (TNtuple*)f.Get("ntuple3") |
advanced/microbeam/plot.C 파일의 178 번째 라인에서 정의되었습니다.
ntuple4 = (TNtuple*)f.Get("ntuple4") |
advanced/microbeam/plot.C 파일의 179 번째 라인에서 정의되었습니다.
TNtuple* ntupleR = new TNtuple("Rmax","ntuple","Z2:Y2:X2") |
advanced/microbeam/plot.C 파일의 276 번째 라인에서 정의되었습니다.
TNtuple* ntupleYX = new TNtuple("CYTOPLASM","ntuple","Y:X:vox") |
advanced/microbeam/plot.C 파일의 50 번째 라인에서 정의되었습니다.
TNtuple* ntupleYXN = new TNtuple("NUCLEUS","ntuple","Y:X:vox") |
advanced/microbeam/plot.C 파일의 48 번째 라인에서 정의되었습니다.
TNtuple* ntupleZX = new TNtuple("CYTOPLASM","ntuple","Z:X:vox") |
advanced/microbeam/plot.C 파일의 49 번째 라인에서 정의되었습니다.
scale = 1/h1bis->Integral() |
advanced/microbeam/plot.C 파일의 25 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4AssemblyVolume::AddPlacedAssembly(), G4AssemblyVolume::AddPlacedVolume(), G4HepRepFileXMLWriter::addPoint(), G4BoundingEnvelope::BoundingBoxVsVoxelLimits(), G4ScaledSolid::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4VEnergyLossProcess::BuildLambdaTable(), G4VEmProcess::BuildLambdaTable(), G4Voxelizer::BuildVoxelLimits(), G4GMocrenIO::calcDoseDistScale(), G4BoundingEnvelope::CalculateExtent(), G4ExtrudedSolid::CalculateExtent(), G4ReflectionFactory::CheckScale(), Run::ComputeFluenceError(), G4INCL::Nucleus::computeOneNucleonRecoilKinematics(), G4PionDecayMakeSpin::DaughterPolarization(), G4ScoringCylinder::Draw(), G4ScoringBox::Draw(), G4ScoringCylinder::DrawColumn(), G4ScoringBox::DrawColumn(), G4GMocrenFileSceneHandler::EndSavingGdd(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnABoxBoundary(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnASphereBoundary(), HepGeom::Transform3D::getDecomposition(), G4GMocrenIO::getDoseDistMinMax(), G4MultiUnion::GetGlobalVector(), G4MultiUnion::GetLocalVector(), G4GMocrenIO::getShortDoseDist(), G4GMocrenIO::getShortDoseDistMinMax(), G4ReflectionFactory::IsReflection(), G4ShellData::LoadData(), G4RDShellData::LoadData(), G4GDMLWriteSolids::MultiUnionWrite(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4ReflectionFactory::Place(), G4LowEnergyCompton::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), c2_factory< float_type >::power_law(), G4RPGTwoCluster::ReactionStage(), c2_factory< float_type >::recip(), G4GDMLReadSolids::ReflectedSolidRead(), c2_scaled_function_p< float_type >::reset(), c2_recip_p< float_type >::reset(), c2_power_law_p< float_type >::reset(), G4GMocrenIO::retrieveData2(), G4GMocrenIO::retrieveData3(), G4GMocrenIO::retrieveData4(), CLHEP::Hep3Vector::rotate(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4ReduciblePolygon::ScaleA(), G4ReduciblePolygon::ScaleB(), c2_factory< float_type >::scaled_function(), G4GDMLReadSolids::ScaledSolidRead(), G4GDMLWriteSolids::ScaledWrite(), G4GDMLReadDefine::ScaleRead(), G4GMocrenIO::setDoseDistMinMax(), G4ScreenedNuclearRecoil::SetMFPScaling(), G4VisCommandSceneAddScale::SetNewValue(), DetectorConstruction::SetRadius(), G4GMocrenIO::setShortDoseDist(), G4GMocrenIO::storeData2(), G4GMocrenIO::storeData3(), G4GMocrenIO::storeData4().
Float_t tmp |
advanced/microbeam/plot.C 파일의 36 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : GammaRayTelPhysicsList::AddPackage(), PhysicsList::AddPackage(), ML2PhysicsList::AddPackage(), G4VXTRenergyLoss::AngleXTRdEdx(), G4BinaryLightIonReaction::ApplyYourself(), G4ExtrudedSolid::ApproxSurfaceNormal(), G4StatMFParameters::Beta(), G4DNASmoluchowskiDiffusion::BoundingBox::BoundingBox(), G4ReflectedSolid::BoundingLimits(), CLHEP::MixMaxRng::Branch(), CLHEP::MixMaxRng::BranchInplace(), G4QGSParticipants::BuildInteractions(), G4ReflectedSolid::CalculateExtent(), CellParameterisation::CellParameterisation(), G4QGSParticipants::CheckKinematics(), G4FTFModel::CheckKinematics(), G4GeomTools::comp_ellint_2(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), CLHEP::MixMaxRng::convert1double(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4DiffractiveExcitation::CreateStrings(), G4StatMFParameters::DBetaDT(), G4BinaryLightIonReaction::DeExciteSpectatorNucleus(), G4StateManager::DeregisterDependent(), G4QGSParticipants::DeterminePartonMomenta(), G4Paraboloid::DistanceToIn(), G4Trd::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Para::DistanceToIn(), G4Trap::DistanceToIn(), G4Ellipsoid::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistTubsSide::DistanceToSurface(), G4LogConsts::dp2uint64(), G4PhysicsListHelper::DumpOrdingParameterTable(), G4QGSParticipants::FinalizeKinematics(), G4FTFModel::FinalizeKinematics(), G4ProcessManager::FindInsertPosition(), CLHEP::RandBreitWigner::fireM2(), G4DiffractiveSplitableHadron::G4DiffractiveSplitableHadron(), G4DNARevertProbability::G4DNARevertProbability(), G4FTFModel::G4FTFModel(), G4MoleculeShootMessenger::G4MoleculeShootMessenger(), G4SwapObj(), G4SwapPtr(), G4VGaussianQuadrature::GammaLogarithm(), G4NuclNuclDiffuseElastic::GammaLogarithm(), CLHEP::gammln(), CLHEP::HepStat::gammln(), G4Abla::gammln(), G4VXTRenergyLoss::GetAngleVector(), G4NuclNuclDiffuseElastic::GetErf(), G4NuclNuclDiffuseElastic::GetErfSer(), RE02PSEnergyDeposit::GetIndex(), RE02PSNofStep::GetIndex(), RE02PSPassageCellFlux::GetIndex(), RE02PSCellFlux::GetIndex(), RE02PSFlatSurfaceCurrent::GetIndex(), RE02PSFlatSurfaceFlux::GetIndex(), G4PhysicsListHelper::GetOrdingParameter(), G4QGSParticipants::GetResiduals(), G4FTFModel::GetResiduals(), G4VCurvedTrajectoryFilter::GimmeThePointsAndForgetThem(), G4ParticleHPElementData::Harmonise(), G4ParticleHPChannel::Harmonise(), G4FTFModel::Init(), G4DNABornIonisationModel1::Initialise(), G4DNABornIonisationModel2::Initialise(), G4MicroElecInelasticModel::Initialise(), G4UIaliasList::List(), MyGamma::LnGamma(), G4OpenInventorXtExaminerViewer::loadViewPts(), G4ExtrudedSolid::MakeDownFacet(), G4StatMFMicroManager::MakePartition(), G4ExtrudedSolid::MakeUpFacet(), MarshaledG4String::marshal1(), MarshaledExN04MuonHit::marshal1(), MarshaledExN04TrackerHit::marshal1(), MarshaledG4VHitsCollection::marshal1(), MarshaledG4HCofThisEvent::marshal1(), MarshaledG4HitsCollection::marshal1(), MarshaledExN02TrackerHit::marshal1(), MarshaledExN04CalorimeterHit::marshal1(), MarshaledG4THitsCollection< T >::marshal1(), MarshaledExN04TrackerHit::marshal2(), MarshaledExN04MuonHit::marshal2(), MarshaledG4VHitsCollection::marshal2(), MarshaledExN04CalorimeterHit::marshal2(), MarshaledExN02TrackerHit::marshal2(), MarshaledExN02TrackerHit::marshal3(), MarshaledG4VHitsCollection::marshal3(), MarshaledExN04CalorimeterHit::marshal3(), MarshaledExN02TrackerHit::marshal4(), MarshaledExN04CalorimeterHit::marshal4(), G4ParticleHPVector::Merge(), G4Tokenizer::operator()(), G4OpenInventorXtExaminerViewer::processSoEvent(), G4GeneratorPrecompoundInterface::PropagateNuclNucl(), ptwX_reverse(), ptwXY_scaleOffsetXAndY(), G4PhysicsListHelper::ReadInDefaultOrderingParameter(), G4PhysicsListHelper::ReadOrdingParameterTable(), G4PhysicsListHelper::RegisterProcess(), G4StateManager::RemoveDependent(), G4StatDouble::rms(), G4ParticleHPLabAngularEnergy::Sample(), G4ParticleHPProduct::Sample(), G4QGSParticipants::SamplingNucleonKinematics(), G4FTFModel::SamplingNucleonKinematics(), G4SandiaTable::SandiaSwap(), G4OpenInventorXtExaminerViewer::saveViewPt(), G4VPartonStringModel::Scatter(), G4DNARevertProbability::SetBoundaries(), G4DiffractiveSplitableHadron::SetFirstParton(), G4BinaryLightIonReaction::SetLighterAsProjectile(), G4ReactionTableMessenger::SetNewValue(), G4ParticleMessenger::SetNewValue(), G4ProcessManager::SetProcessOrderingToSecond(), G4DiffractiveSplitableHadron::SetSecondParton(), G4GenericMessenger::Command::SetUnit(), CLHEP::RandBreitWigner::shootM2(), G4ErrorSymMatrix::similarity(), G4ErrorSymMatrix::similarityT(), G4QGSMSplitableHadron::SoftSplitUp(), G4ExpConsts::sp2uint32(), G4LogConsts::sp2uint32(), G4XTRRegularRadModel::SpectralXTRdEdx(), G4XTRTransparentRegRadModel::SpectralXTRdEdx(), G4RegularXTRadiator::SpectralXTRdEdx(), G4TransparentRegXTRadiator::SpectralXTRdEdx(), XTRTransparentRegRadModel::SpectralXTRdEdx(), G4LundStringFragmentation::SplitLast(), G4DiffractiveSplitableHadron::SplitUp(), G4ExpConsts::uint322sp(), G4LogConsts::uint322sp(), G4ExpConsts::uint642dp(), G4LogConsts::uint642dp(), G4OpenInventorXtExaminerViewer::viewPtAutoName(), xDataXML_stringTo_double(), xDataXML_stringTo_xDataTOM_Int(), XML_ExternalEntityParserCreate(), XML_ParserCreateNS().
Float_t vox = 0 |
advanced/microbeam/plot.C 파일의 39 번째 라인에서 정의되었습니다.
Float_t voxelSizeX |
advanced/microbeam/plot.C 파일의 40 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : while().
Float_t voxelSizeY |
advanced/microbeam/plot.C 파일의 40 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : while().
Float_t voxelSizeZ |
advanced/microbeam/plot.C 파일의 40 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : while().
Float_t X |
advanced/microbeam/plot.C 파일의 38 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4EmCorrections::BarkasCorrection(), G4hImpactIonisation::BarkasTerm(), G4InuclSpecialFunctions::bindingEnergyAsymptotic(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4NonEquilibriumEvaporator::deExcite(), G4EquilibriumEvaporator::deExcite(), G4FissionParameters::DefineParameters(), G4AtimaFluctuations::Dispersion(), PerspectiveVisAction::ExtendedDraw(), G4FPYSamplingOps::G4SampleWatt(), CLHEP::RandBinomial::genBinomial(), G4VXTRenergyLoss::GetComptonPerAtom(), G4ParticleHPThermalScatteringData::GetX(), G4Abla::imf(), G4PolarizedComptonCrossSection::Initialize(), G4HETCFragment::IntegrateEmissionProbability(), G4Abla::part_fiss(), G4Fissioner::potentialMinimization().
Double_t x |
advanced/microbeam/plot.C 파일의 277 번째 라인에서 정의되었습니다.
Double_t X1 |
advanced/microbeam/plot.C 파일의 264 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4ParticleHPKallbachMannSyst::A(), G4InuclSpecialFunctions::bindingEnergyAsymptotic(), G4EquilibriumEvaporator::deExcite(), G4TripathiLightCrossSection::GetElementCrossSection(), G4ElasticHadrNucleusHE::GetQ2_2(), G4EquilibriumEvaporator::getQF(), MCGIDI_KalbachMann_sampleEp(), G4Fissioner::potentialMinimization(), G4BetheHeitler5DModel::SampleSecondaries().
Double_t X2 |
Xc = -1295.59e3 - 955e3*sin(10*TMath::Pi()/180) |
advanced/microbeam/plot.C 파일의 264 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : for().
Float_t xVox |
advanced/microbeam/plot.C 파일의 36 번째 라인에서 정의되었습니다.
Double_t xx |
advanced/microbeam/plot.C 파일의 277 번째 라인에서 정의되었습니다.
Float_t Y |
advanced/microbeam/plot.C 파일의 38 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : CLHEP::MixMaxRng::apply_bigskip(), G4DNAPTBAugerModel::CalculAugerEnergyFor(), G4DiffractiveExcitation::CreateStrings(), epsilon(), G4RKFieldIntegrator::Erf(), PerspectiveVisAction::ExtendedDraw(), G4Abla::fission_width(), G4Abla::fomega_sp(), G4Abla::func_trans(), G4FPYSamplingOps::G4SampleWatt(), G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy(), G4ParticleHPFFFissionFS::Init(), G4HETCFragment::IntegrateEmissionProbability(), CLHEP::MixMaxRng::iterate(), LXeWLSSlab::LXeWLSSlab().
Double_t y |
advanced/microbeam/plot.C 파일의 277 번째 라인에서 정의되었습니다.
Double_t Y1 |
advanced/microbeam/plot.C 파일의 264 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4HETCFragment::BetaRand(), for(), G4Fissioner::potentialMinimization().
Double_t Y2 |
advanced/microbeam/plot.C 파일의 264 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4HETCFragment::BetaRand(), G4Fissioner::potentialMinimization().
Float_t yVox |
advanced/microbeam/plot.C 파일의 36 번째 라인에서 정의되었습니다.
Float_t Z |
advanced/microbeam/plot.C 파일의 38 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4RDVCrossSectionHandler::ActiveElements(), G4VCrossSectionHandler::ActiveElements(), G4PixeCrossSectionHandler::ActiveElements(), G4ElementData::AddComponent(), G4NistElementBuilder::AddElement(), G4NistMaterialBuilder::AddElementByAtomCount(), G4NistMaterialBuilder::AddElementByWeightFraction(), G4Element::AddNaturalIsotopes(), G4NuclearLevelData::AddPrivateData(), G4RadioactiveDecayBase::AddUserDecayDataFile(), G4RadioactiveDecay::AddUserDecayDataFile(), G4AdjointPhotoElectricModel::AdjointCrossSectionPerAtom(), G4VAtomDeexcitation::AlongStepDeexcitation(), G4NuclearStopping::AlongStepDoIt(), G4ParaFissionModel::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4NeutrinoElectronCcModel::ApplyYourself(), G4NeutrinoElectronNcModel::ApplyYourself(), G4LEpp::ApplyYourself(), G4LEHadronProtonElastic::ApplyYourself(), G4NeutronElectronElModel::ApplyYourself(), G4LEnp::ApplyYourself(), G4PreCompoundModel::ApplyYourself(), G4LFission::ApplyYourself(), G4MuMinusCapturePrecompound::ApplyYourself(), G4EmCaptureCascade::ApplyYourself(), G4MuonMinusBoundDecay::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4INCLXXInterface::ApplyYourself(), G4ParticleHPChannel::ApplyYourself(), G4LFission::Atomas(), G4NucleiProperties::AtomicMass(), G4FissionBarrier::BarashenkovFissionBarrier(), G4EmCorrections::BarkasCorrection(), RunAction::BeginOfRunAction(), G4NucleiProperties::BindingEnergy(), G4Evaporation::BreakFragment(), G4InuclEvaporation::BreakItUp(), G4ExcitationHandler::BreakItUp(), G4WilsonAblationModel::BreakItUp(), G4UnstableFragmentBreakUp::BreakUpChain(), G4AugerData::BuildAugerTransitionTable(), G4RDAugerData::BuildAugerTransitionTable(), G4EmCorrections::BuildCorrectionVector(), G4AdjointCSManager::BuildCrossSectionMatrices(), G4CrossSectionHandler::BuildCrossSectionsForMaterials(), G4RDCrossSectionHandler::BuildCrossSectionsForMaterials(), G4RDBremsstrahlungCrossSectionHandler::BuildCrossSectionsForMaterials(), G4RDeIonisationCrossSectionHandler::BuildCrossSectionsForMaterials(), G4BremsstrahlungCrossSectionHandler::BuildCrossSectionsForMaterials(), G4eIonisationCrossSectionHandler::BuildCrossSectionsForMaterials(), G4PixeCrossSectionHandler::BuildCrossSectionsForMaterials(), G4KokoulinMuonNuclearXS::BuildCrossSectionTable(), G4NistElementBuilder::BuildElement(), G4hImpactIonisation::BuildLambdaTable(), G4LowEnergyBremsstrahlung::BuildLossTable(), G4LowEnergyIonisation::BuildLossTable(), G4NistMaterialBuilder::BuildMaterial(), G4ScreenedCoulombCrossSection::BuildMFPTables(), G4PenelopeOscillatorManager::BuildOscillatorTable(), G4ParticleHPJENDLHEData::BuildPhysicsTable(), G4NeutronElasticXS::BuildPhysicsTable(), G4NeutronCaptureXS::BuildPhysicsTable(), G4NeutronInelasticXS::BuildPhysicsTable(), G4ParticleInelasticXS::BuildPhysicsTable(), G4PenelopeBremsstrahlungFS::BuildScaledXSTable(), G4StatMFMicroCanonical::CalcFreeInternalEnergy(), G4GEMProbability::CalcProbability(), G4Radioactivation::CalculateChainsFromParent(), G4RadioactiveDecay::CalculateChainsFromParent(), G4RDGenerator2BN::Calculatedsdkdt(), G4Generator2BN::Calculatedsdkdt(), G4PenelopeBremsstrahlungAngular::CalculateEffectiveZ(), G4MuonVDNuclearModel::CalculateEMVertex(), G4PreCompoundTransitions::CalculateProbability(), CexmcHadronicProcess::CalculateTargetNucleus(), G4StatMFMacroCanonical::CalculateTemperature(), GFlashShowerModel::CheckContainment(), G4PDGCodeChecker::CheckForNuclei(), G4StatMFChannel::CheckFragments(), G4BinaryCascade::CheckPauliPrinciple(), G4QuasiElRatios::ChExElCoef(), G4QuasiElRatios::ChExer(), G4StatMFMacroCanonical::ChooseAandZ(), G4FermiFragmentsPoolVI::ClosestChannels(), G4INCL::Cluster::Cluster(), G4VCrossSectionDataSet::ComputeCrossSection(), G4LivermorePolarizedPhotoElectricGDModel::ComputeCrossSectionPerAtom(), G4LivermorePhotoElectricModel::ComputeCrossSectionPerAtom(), G4LivermorePolarizedPhotoElectricModel::ComputeCrossSectionPerAtom(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4AnnihiToMuPair::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeDEDXPerVolume(), G4LivermoreBremsstrahlungModel::ComputeDXSectionPerAtom(), G4SeltzerBergerModel::ComputeDXSectionPerAtom(), G4WentzelVIRelModel::ComputeEffectiveMass(), G4SandiaTable::ComputeMatSandiaMatrix(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), G4SandiaTable::ComputeMatTable(), G4Material::ComputeNuclearInterLength(), G4LivermoreComptonModel::ComputeScatteringFunction(), G4LowEPComptonModel::ComputeScatteringFunction(), G4LowEPPolarizedComptonModel::ComputeScatteringFunction(), Construct(), Materials::Construct(), MyMaterials::Construct(), QMaterials::Construct(), B03DetectorConstruction::Construct(), B02DetectorConstruction::Construct(), B01DetectorConstruction::Construct(), CML2Ph_BoxInBox::Construct(), G4MuonicAtomHelper::ConstructMuonicAtom(), G4NistMaterialBuilder::ConstructNewIdealGasMaterial(), G4IonTable::Contains(), G4BGGNucleonInelasticXS::CoulombFactor(), G4BGGNucleonElasticXS::CoulombFactor(), G4BGGPionInelasticXS::CoulombFactor(), G4PenelopeIonisationCrossSection::CrossSection(), G4MuonicAtomDecay::DecayIt(), G4ICRU73QOModel::DEDXPerElement(), G4Fissioner::deExcite(), G4PreCompoundModel::DeExcite(), G4LowEnergyIonisation::DeexciteAtom(), G4HumanPhantomMaterial::DefineMaterials(), BrachyMaterial::DefineMaterials(), G4IonFluctuations::Dispersion(), G4INCL::CoulombNonRelativistic::distortOut(), G4ScreenedCoulombClassicalKinematics::DoCollisionStep(), G4VIsotopeTable::DumpTable(), G4GDMLReadMaterials::ElementRead(), G4FissionProbability::EmissionProbability(), G4CompetitiveFission::EmittedFragment(), PerspectiveVisAction::ExtendedDraw(), G4Pow::factorial(), IORTMatrix::Fill(), HadrontherapyMatrix::Fill(), HadrontherapyLet::FillEnergySpectrum(), G4NistElementBuilder::FindElement(), G4IonTable::FindIon(), G4IonTable::FindIonInMaster(), G4NistElementBuilder::FindOrBuildElement(), G4PenelopeIonisationCrossSection::FindShellIDIndex(), G4StatMF::FindTemperatureOfBreakingChannel(), G4FissionBarrier::FissionBarrier(), G4Abla::fissionDistri(), G4CompetitiveFission::FissionKineticEnergy(), G4DopplerProfile::G4DopplerProfile(), G4GIDI_Misc_Z_A_m_ToName(), G4IonisParamElm::G4IonisParamElm(), G4NuclearLevelData::G4NuclearLevelData(), G4RDAtomicTransitionManager::G4RDAtomicTransitionManager(), G4RDDopplerProfile::G4RDDopplerProfile(), G4SandiaTable::G4SandiaTable(), G4fissionEvent::G4SmpNugDist(), CLHEP::MixMaxRng::generate(), B3PrimaryGeneratorAction::GeneratePrimaries(), CLHEP::MixMaxRng::get_next_float_packbits(), G4NistManager::GetA27(), G4AblaVirtualData::getAlpha(), G4NistElementBuilder::GetAtomicMass(), G4NistElementBuilder::GetAtomicMassAmu(), G4QMDNucleus::GetAtomicNumber(), G4AugerData::GetAugerTransition(), G4RDAugerData::GetAugerTransition(), G4AugerData::GetAugerTransitions(), G4RDAugerData::GetAugerTransitions(), G4SigmaPlusField::GetBarrier(), G4SigmaMinusField::GetBarrier(), G4AntiProtonField::GetBarrier(), G4KaonMinusField::GetBarrier(), G4KaonPlusField::GetBarrier(), G4PionPlusField::GetBarrier(), G4PionMinusField::GetBarrier(), G4AblaVirtualData::getBeta2(), G4AblaVirtualData::getBeta4(), G4AtomicShells_EADL::GetBindingEnergy(), G4AtomicShells::GetBindingEnergy(), G4LivermorePhotoElectricModel::GetBindingEnergy(), G4QuasiElRatios::GetChExFactor(), G4ElementData::GetComponentDataByID(), G4VXTRenergyLoss::GetComptonPerAtom(), G4NeutronInelasticCrossSection::GetCrossSection(), G4CrossSectionDataStore::GetCrossSection(), G4NuclNuclDiffuseElastic::GetDiffuseElasticSumXsc(), G4DiffuseElastic::GetDiffuseElasticSumXsc(), G4AblaVirtualData::getEcnz(), G4ElementData::GetElement2DData(), G4NeutronInelasticCrossSection::GetElementCrossSection(), G4ProtonInelasticCrossSection::GetElementCrossSection(), G4ChargeExchangeProcess::GetElementCrossSection(), G4KokoulinMuonNuclearXS::GetElementCrossSection(), G4CrossSectionElastic::GetElementCrossSection(), G4CrossSectionInelastic::GetElementCrossSection(), G4NeutronElasticXS::GetElementCrossSection(), G4BGGNucleonInelasticXS::GetElementCrossSection(), G4BGGPionElasticXS::GetElementCrossSection(), G4NeutronInelasticXS::GetElementCrossSection(), G4ParticleInelasticXS::GetElementCrossSection(), G4BGGNucleonElasticXS::GetElementCrossSection(), G4BGGPionInelasticXS::GetElementCrossSection(), G4ElementData::GetElementData(), G4DensityEffectData::GetElementIndex(), G4INCL::ParticleTable::getElementName(), G4PhotonEvaporation::GetEmissionProbability(), G4BinaryCascade::GetExcitationEnergy(), G4INCL::ParticleTable::getFermiMomentumConstantLight(), G4SigmaPlusField::GetField(), G4SigmaMinusField::GetField(), G4KaonZeroField::GetField(), G4SigmaZeroField::GetField(), G4KaonMinusField::GetField(), G4KaonPlusField::GetField(), G4PionPlusField::GetField(), G4PionZeroField::GetField(), G4AntiProtonField::GetField(), G4PionMinusField::GetField(), G4PairingCorrection::GetFissionPairingCorrection(), G4INCL::ParticleTable::getINCLMass(), XrayFluoSiLiDetectorType::GetInfData(), XrayFluoHPGeDetectorType::GetInfData(), G4IonTable::GetIon(), G4IonTable::GetIonName(), G4NeutronCaptureXS::GetIsoCrossSection(), G4NeutronInelasticXS::GetIsoCrossSection(), G4ParticleInelasticXS::GetIsoCrossSection(), G4ComponentGGHadronNucleusXsc::GetIsoCrossSection(), G4IsotopeMagneticMomentTable::GetIsotope(), G4NistElementBuilder::GetIsotopeAbundance(), G4IsotopeMagneticMomentTable::GetIsotopeByIsoLvl(), G4NistElementBuilder::GetIsotopeMass(), G4INCL::ParticleTable::getIUPACElementName(), G4NuclearLevelData::GetLevelManager(), G4NistManager::GetLOGAMU(), G4NuclearLevelData::GetMaxA(), G4AblaVirtualData::getMexp(), G4AblaVirtualData::getMexpID(), G4NuclearLevelData::GetMinA(), G4MuonicAtomHelper::GetMuonCaptureRate(), G4MuonMinusBoundDecay::GetMuonCaptureRate(), G4MuonicAtomHelper::GetMuonDecayRate(), G4MuonMinusBoundDecay::GetMuonDecayRate(), G4IonTable::GetMuonicAtom(), G4MuonicAtomHelper::GetMuonZeff(), G4MuonMinusBoundDecay::GetMuonZeff(), G4ParticleHPNames::GetName(), G4NistElementBuilder::GetNistFirstIsotopeN(), G4QMDNucleus::GetNuclearMass(), G4NucleiPropertiesTableAME12::GetNuclearMass(), G4NucleiPropertiesTableAME03::GetNuclearMass(), G4INCL::ParticleTable::getNuclearRadius(), G4IonTable::GetNucleusByEncoding(), G4IonTable::GetNucleusMass(), G4ElementData::GetNumberOfComponents(), G4AtomicShells_EADL::GetNumberOfElectrons(), G4AtomicShells::GetNumberOfElectrons(), G4NistElementBuilder::GetNumberOfNistIsotopes(), G4QAOLowEnergyLoss::GetNumberOfShell(), G4AtomicShells_EADL::GetNumberOfShells(), G4AtomicShells::GetNumberOfShells(), G4ICRU73QOModel::GetNumberOfShells(), G4QAOLowEnergyLoss::GetOccupationNumber(), G4QAOLowEnergyLoss::GetOscillatorEnergy(), G4ICRU73QOModel::GetOscillatorEnergy(), G4AblaVirtualData::getPace2(), G4PairingCorrection::GetPairingCorrection(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorIn(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorTot(), G4FissionProductYieldDist::GetParticleDefinition(), G4ProtonInelasticCrossSection::GetProtonCrossSection(), G4INCL::ParticleTable::getRadiusParameter(), G4INCL::HFB::getRadiusParameterHFB(), G4INCL::ParticleTable::getRealMass(), G4AblaVirtualData::getRms(), G4SandiaTable::GetSandiaCofPerAtom(), G4SandiaTable::GetSandiaPerAtom(), G4ScreenedCoulombCrossSection::GetScreening(), G4INCL::ParticleTable::getSeparationEnergyReal(), G4ShellCorrection::GetShellCorrection(), G4ICRU73QOModel::GetShellEnergy(), G4QAOLowEnergyLoss::GetShellStrength(), G4ICRU73QOModel::GetShellStrength(), XrayFluoHPGeDetectorType::GetSupData(), XrayFluoSiLiDetectorType::GetSupData(), G4INCL::HFB::getSurfaceDiffusenessHFB(), G4AtomicShells_EADL::GetTotalBindingEnergy(), G4AtomicShells::GetTotalBindingEnergy(), G4NistElementBuilder::GetTotalElectronBindingEnergy(), G4ElementData::GetValueForElement(), G4AblaVirtualData::getVgsld(), G4NistElementBuilder::GetZ(), G4SandiaTable::GetZtoA(), G4ParticleHP2PInelasticFS::Init(), G4ParticleHPNAInelasticFS::Init(), G4ParticleHPNHe3InelasticFS::Init(), G4ParticleHPNPInelasticFS::Init(), G4ParticleHP2NAInelasticFS::Init(), G4ParticleHP2NDInelasticFS::Init(), G4ParticleHP2NInelasticFS::Init(), G4ParticleHP2NPInelasticFS::Init(), G4ParticleHPDInelasticFS::Init(), G4ParticleHPHe3InelasticFS::Init(), G4ParticleHPN2PInelasticFS::Init(), G4ParticleHPNDInelasticFS::Init(), G4ParticleHPNInelasticFS::Init(), G4ParticleHPNTInelasticFS::Init(), G4ParticleHPNXInelasticFS::Init(), G4ParticleHPPDInelasticFS::Init(), G4ParticleHPPTInelasticFS::Init(), G4ParticleHPTInelasticFS::Init(), G4ParticleHPPInelasticFS::Init(), G4ParticleHP4NInelasticFS::Init(), G4ParticleHP3NAInelasticFS::Init(), G4ParticleHP3NInelasticFS::Init(), G4ParticleHP3NPInelasticFS::Init(), G4ParticleHPAInelasticFS::Init(), G4ParticleHPCaptureFS::Init(), G4ParticleHPElementData::Init(), G4LivermoreRayleighModel::Initialise(), G4LivermoreNuclearGammaConversionModel::Initialise(), G4BoldyshevTripletModel::Initialise(), G4LivermoreGammaConversionModelRC::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermorePolarizedGammaConversionModel::Initialise(), G4LivermorePolarizedPhotoElectricGDModel::Initialise(), G4LivermoreComptonModel::Initialise(), G4LivermorePolarizedPhotoElectricModel::Initialise(), G4LivermorePhotoElectricModel::Initialise(), G4LivermorePolarizedRayleighModel::Initialise(), G4LivermorePolarizedComptonModel::Initialise(), G4AtomicTransitionManager::Initialise(), G4LivermoreBremsstrahlungModel::Initialise(), G4SeltzerBergerModel::Initialise(), G4FermiFragmentsPoolVI::Initialise(), G4NeutronElasticXS::Initialise(), G4LowEPComptonModel::Initialise(), G4NeutronCaptureXS::Initialise(), G4NeutronInelasticXS::Initialise(), G4ParticleInelasticXS::Initialise(), G4LowEPPolarizedComptonModel::Initialise(), G4NistElementBuilder::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4EmSaturation::InitialiseBirksCoefficient(), G4ElementData::InitialiseForComponent(), G4ElementData::InitialiseForElement(), G4NuclearLevelData::InitialiseForIsotope(), G4VEmModel::InitialiseForMaterial(), G4PhotonEvaporation::InitialiseLevelManager(), G4NuclNuclDiffuseElastic::InitialiseOnFly(), G4DiffuseElasticV2::InitialiseOnFly(), G4DiffuseElastic::InitialiseOnFly(), G4LivermoreGammaConversionModel::InitialiseProbability(), G4StatMFMacroCanonical::Initialize(), G4StatMFMicroCanonical::Initialize(), G4StatMFMicroManager::Initialize(), G4WendtFissionFragmentGenerator::InitializeANucleus(), G4NuclNuclDiffuseElastic::InitParameters(), G4NuclNuclDiffuseElastic::InitParametersGla(), G4IonTable::Insert(), G4IonTable::InsertWorker(), G4UPiNuclearCrossSection::Interpolate(), G4EmCorrections::IonHighOrderCorrections(), G4NeutrinoElectronCcModel::IsApplicable(), G4NeutrinoElectronNcModel::IsApplicable(), G4HadronNucleonXsc::IsApplicable(), G4NeutronElectronElModel::IsApplicable(), G4RadioactiveDecayBase::IsApplicable(), G4RadioactiveDecay::IsApplicable(), G4NeutronInelasticXS::IsoCrossSection(), G4ParticleInelasticXS::IsoCrossSection(), G4GDMLReadMaterials::IsotopeRead(), G4INCL::ClusterDecay::isStable(), G4EmCorrections::KShellCorrection(), G4FissionLevelDensityParameter::LevelDensityParameter(), G4ShellData::LoadData(), G4RDShellData::LoadData(), G4BremsstrahlungParameters::LoadData(), G4eIonisationParameters::LoadData(), G4RDBremsstrahlungParameters::LoadData(), G4RDeIonisationParameters::LoadData(), G4AugerData::LoadData(), G4RDAugerData::LoadData(), G4RDVCrossSectionHandler::LoadData(), G4VCrossSectionHandler::LoadData(), G4NativeScreenedCoulombCrossSection::LoadData(), G4RadioactiveDecayBase::LoadDecayTable(), G4RadioactiveDecay::LoadDecayTable(), G4VCrossSectionHandler::LoadNonLogData(), G4INCL::Store::loadParticles(), G4DopplerProfile::LoadProfile(), G4RDDopplerProfile::LoadProfile(), XrayFluoHPGeDetectorType::LoadResponseData(), XrayFluoSiLiDetectorType::LoadResponseData(), G4RDVCrossSectionHandler::LoadShellData(), G4PixeCrossSectionHandler::LoadShellData(), G4VCrossSectionHandler::LoadShellData(), G4Pow::log10Z(), G4Pow::logfactorial(), G4Pow::logZ(), lPoPs_addParticleIfNeeded(), G4EmCorrections::LShellCorrection(), main(), G4FissionProductYieldDist::MakeIsotopeName(), G4CascadeCoalescence::makeLightIon(), G4MuPairProductionModel::MakeSamplingTables(), G4GDMLReadMaterials::MaterialRead(), G4NuclearLevelData::MaxLevelEnergy(), G4MuPairProductionModel::MaxSecondaryEnergyForElement(), MCGIDI_particle_getInternalID(), MCGIDI_POP_new(), G4hCoulombScatteringModel::MinPrimaryEnergy(), G4eCoulombScatteringModel::MinPrimaryEnergy(), G4AtomicTransitionManager::NumberOfShells(), G4AugerData::NumberOfVacancies(), G4RDAugerData::NumberOfVacancies(), CML2Acc1::otherMaterials(), G4INCL::ParticleTable::parseIUPACElement(), G4PreCompoundTransitions::PerformTransition(), PoP_setZ_A_l(), G4LowEnergyRayleigh::PostStepDoIt(), G4LowEnergyCompton::PostStepDoIt(), G4LowEnergyPhotoElectric::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4IonTable::PreloadNuclide(), G4INCL::INCL::prepareReaction(), G4DopplerProfile::PrintData(), G4RDDopplerProfile::PrintData(), G4ShellData::PrintData(), G4BremsstrahlungParameters::PrintData(), G4eIonisationParameters::PrintData(), G4RDShellData::PrintData(), G4RDeIonisationParameters::PrintData(), G4RDBremsstrahlungParameters::PrintData(), G4AugerData::PrintData(), G4RDAugerData::PrintData(), G4NistElementBuilder::PrintElement(), G4INCL::Store::printParticleConfiguration(), HadrontherapyDetectorSD::ProcessHits(), IORTDetectorSD::ProcessHits(), G4GeneratorPrecompoundInterface::Propagate(), G4GeneratorPrecompoundInterface::PropagateNuclNucl(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4LivermoreRayleighModel::ReadData(), G4BoldyshevTripletModel::ReadData(), G4LivermoreNuclearGammaConversionModel::ReadData(), G4LivermoreComptonModel::ReadData(), G4LivermorePolarizedPhotoElectricGDModel::ReadData(), G4LivermoreGammaConversionModel::ReadData(), G4LivermoreGammaConversionModelRC::ReadData(), G4LivermorePolarizedGammaConversionModel::ReadData(), G4SeltzerBergerModel::ReadData(), G4LivermoreBremsstrahlungModel::ReadData(), G4LivermorePolarizedPhotoElectricModel::ReadData(), G4LivermorePolarizedRayleighModel::ReadData(), G4LivermorePhotoElectricModel::ReadData(), G4LowEPComptonModel::ReadData(), G4LivermorePolarizedComptonModel::ReadData(), G4LowEPPolarizedComptonModel::ReadData(), G4PenelopeOscillatorManager::ReadElementData(), CCalMaterialFactory::readElements(), G4ParticleHPChannel::Register(), G4DNARuddIonisationExtendedModel::RejectionFunction(), G4IonFluctuations::RelativisticFactor(), G4IonTable::Remove(), G4ParticleHPIsotropic::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4ParticleHPLabAngularEnergy::Sample(), G4ParticleHPDiscreteTwoBody::Sample(), G4ParticleHPContAngularPar::Sample(), G4RayleighAngularGenerator::SampleDirection(), G4AntiNuclElastic::SampleInvariantT(), G4ChipsElasticModel::SampleInvariantT(), G4ElasticHadrNucleusHE::SampleInvariantT(), G4XrayRayleighModel::SampleSecondaries(), G4LivermoreRayleighModel::SampleSecondaries(), G4LivermorePolarizedPhotoElectricGDModel::SampleSecondaries(), G4DNARuddIonisationExtendedModel::SampleSecondaries(), G4DNARuddIonisationModel::SampleSecondaries(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4LivermorePolarizedPhotoElectricModel::SampleSecondaries(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4LivermorePhotoElectricModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4LDMBremModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4PEEffectFluoModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4PAIModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4GammaTransition::SampleTransition(), G4CrossSectionDataStore::SampleZandA(), G4QuasiElasticChannel::Scatter(), G4QuasiElRatios::Scatter(), HistoManager::ScoreNewTrack(), G4NeutronCaptureXS::SelectIsotope(), G4NeutronInelasticXS::SelectIsotope(), G4ParticleInelasticXS::SelectIsotope(), G4RDVCrossSectionHandler::SelectRandomAtom(), G4VCrossSectionHandler::SelectRandomAtom(), G4PixeCrossSectionHandler::SelectRandomAtom(), G4ScreenedCoulombCrossSection::SelectRandomUnweightedTarget(), G4WilsonAblationModel::SelectSecondariesByDefault(), G4ElementSelector::SelectZandA(), G4AblaVirtualData::setAlpha(), G4IsotopeProperty::SetAtomicNumber(), G4AblaVirtualData::setBeta2(), G4AblaVirtualData::setBeta4(), G4eBremsstrahlungRelModel::SetCurrentElement(), G4eBremParametrizedModel::SetCurrentElement(), G4AblaVirtualData::setEcnz(), G4KM_OpticalEqRhs::SetFactor(), G4VPolarizedCrossSection::SetMaterial(), G4AblaVirtualData::setMexp(), G4AblaVirtualData::setMexpID(), G4RadioactiveDecayBaseMessenger::SetNewValue(), G4NistMessenger::SetNewValue(), G4RadioactiveDecaymessenger::SetNewValue(), G4Polycone::SetOriginalParameters(), G4Polyhedra::SetOriginalParameters(), G4AblaVirtualData::setPace2(), G4Nucleus::SetParameters(), G4AblaVirtualData::setRms(), G4INCL::Config::setTargetZ(), G4ParticleHPReactionWhiteBoard::SetTargZ(), G4ScreeningMottCrossSection::SetupKinematic(), G4IonCoulombCrossSection::SetupTarget(), G4WentzelOKandVIxSection::SetupTarget(), G4AblaVirtualData::setVgsld(), G4INCL::Cluster::setZ(), G4EmCorrections::ShellCorrection(), G4RPGNeutronInelastic::SlowNeutron(), G4RPGProtonInelastic::SlowProton(), HadrontherapyMatrix::StoreDoseFluenceAscii(), IORTMatrix::StoreDoseFluenceRoot(), G4NuclearLevelData::StreamLevels(), G4ePairProduction::StreamProcessInfo(), G4MuPairProduction::StreamProcessInfo(), G4NuclNuclDiffuseElastic::TestAngleTable(), G4DiffuseElastic::TestAngleTable(), G4PolarizedComptonCrossSection::TotalXSection(), G4Channeling::UpdateParameters(), IORTSteppingAction::UserSteppingAction(), G4RDVCrossSectionHandler::ValueForMaterial(), G4PixeCrossSectionHandler::ValueForMaterial(), G4VCrossSectionHandler::ValueForMaterial(), G4Pow::Z13(), G4NuclearLevelData::~G4NuclearLevelData().
Double_t z |
advanced/microbeam/plot.C 파일의 277 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4GMocrenIO::addDoseDist(), HistoManager::AddLeakingParticle(), RE06DetectorConstruction::AddMaterial(), Run::AddPhantomStep(), HistoManager::AddTargetStep(), G4DNABrownianTransportation::AlongStepDoIt(), G4ITSteppingVerbose::AlongStepDoItAllDone(), G4SteppingVerbose::AlongStepDoItAllDone(), G4ITSteppingVerbose::AlongStepDoItOneByOne(), G4SteppingVerbose::AlongStepDoItOneByOne(), G4Analyser::analyse(), G4AntiNeutronAnnihilationAtRest::AntiNeutronAnnihilation(), G4ITSteppingVerbose::AtRestDoItInvoked(), G4SteppingVerbose::AtRestDoItInvoked(), CLHEP::HepRotation::axis(), G4Abla::barfit(), Barycenter::Barycenter(), G4AtimaEnergyLossModel::Bethek_dedx_e(), G4PolynomialPDF::Bisect(), CLHEP::HepLorentzVector::boost(), G4GDMLReadSolids::BoxRead(), G4DiffuseElasticV2::BuildAngleTable(), G4DiffuseElastic::BuildAngleTable(), G4tgbVolume::BuildSolidForDivision(), G4Voxelizer::BuildVoxelLimits(), G4NuclNuclDiffuseElastic::CalculateCoulombPhase(), G4NuclNuclDiffuseElastic::CalculateCoulombPhaseZero(), G4Tet::CalculateExtent(), G4Orb::CalculateExtent(), G4ExtrudedSolid::CalculateExtent(), G4ViewParameters::CatmullRomCubicSplineInterpolation(), CellParameterisation::CellParameterisation(), G4StatMFMacroCanonical::ChooseZ(), ChromosomeParameterisation::ChromosomeParameterisation(), G4IonisParamMat::ComputeIonParameters(), PDBlib::ComputeMatchEdepDNA(), G4SandiaTable::ComputeMatSandiaMatrix(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), RunAction::ComputeMscHighland(), Run::ComputeMscHighland(), G4DNABrownianTransportation::ComputeStep(), CellParameterisation::ComputeTransformation(), NeuronLoadDataFile::ComputeTransformation(), G4GDMLReadSolids::ConeRead(), H02DetectorConstruction::Construct(), ExN04DetectorConstruction::Construct(), G4MIRDPelvis::Construct(), B03DetectorConstruction::Construct(), G4MIRDThyroid::Construct(), OpNoviceDetectorConstruction::Construct(), RE05DetectorConstruction::Construct(), ExP02DetectorConstruction::Construct(), GeometryConstruction::Construct(), B01DetectorConstruction::Construct(), B02DetectorConstruction::Construct(), ExN01DetectorConstruction::Construct(), eRositaDetectorConstruction::Construct(), B5DetectorConstruction::Construct(), ExN02DetectorConstruction::Construct(), ExP01DetectorConstruction::Construct(), XrayFluoMercuryDetectorConstruction::ConstructApparate(), XrayFluoPlaneDetectorConstruction::ConstructApparate(), XrayFluoDetectorConstruction::ConstructApparate(), F04DetectorConstruction::ConstructDetector(), CCalG4Ecal::constructIn(), DetectorConstruction::ConstructMaterials(), GammaRayTelDetectorConstruction::ConstructPayload(), UltraDetectorConstruction::ConstructTableMaterials(), G4NuclNuclDiffuseElastic::CoulombAmplitude(), MuCrossSections::CR_PerAtom(), G4DNAUeharaScreenedRutherfordElasticModel::CrossSectionPerVolume(), G4DNAScreenedRutherfordElasticModel::CrossSectionPerVolume(), csz__huft_build(), G4GDMLReadSolids::CutTubeRead(), G4UnknownDecay::DecayIt(), G4Decay::DecayIt(), G4MuonicAtomDecay::DecayIt(), G4RadioactiveDecayBase::DecayIt(), G4RadioactiveDecay::DecayIt(), G4BraggModel::DEDX(), G4BraggIonModel::DEDX(), ExN04DetectorConstruction::DefineMaterials(), RE05DetectorConstruction::DefineMaterials(), GB03DetectorConstruction::DefineMaterials(), B4cDetectorConstruction::DefineMaterials(), B4dDetectorConstruction::DefineMaterials(), RE06DetectorConstruction::DefineMaterials(), B4DetectorConstruction::DefineMaterials(), DetectorConstruction::DefineMaterials(), RMC01DetectorConstruction::DefineMaterials(), LXeDetectorConstruction::DefineMaterials(), F01DetectorConstruction::DefineMaterials(), F02DetectorConstruction::DefineMaterials(), ExN03DetectorConstruction::DefineMaterials(), F03DetectorConstruction::DefineMaterials(), GammaRayTelDetectorConstruction::DefineMaterials(), G4MagneticFieldModel::DescribeYourselfTo(), G4QGSParticipants::DeterminePartonMomenta(), G4AtimaFluctuations::Dispersion(), G4TwistTubsSide::DistanceToSurface(), G4UIcmdWith3VectorAndUnit::DoIt(), G4ScoringCylinder::Draw(), G4ScoringBox::Draw(), G4ScoringCylinder::DrawColumn(), G4ScoringBox::DrawColumn(), G4VScoreWriter::DumpAllQuantitiesToFile(), G4VScoreWriter::DumpQuantityToFile(), BrachyUserScoreWriter::DumpQuantityToFile(), RE03UserScoreWriter::DumpQuantityToFile(), G4ionEffectiveCharge::EffectiveCharge(), G4Abla::eflmac(), G4Abla::eflmac_profi(), CCalEventAction::EndOfEventAction(), GammaRayTelEventAction::EndOfEventAction(), G4GMocrenFileSceneHandler::EndSavingGdd(), CCaloOrganization::energyInMatrix(), CLHEP::HepStat::erfQ(), G4OpenInventorXtExaminerViewer::evenOutRefParticlePts(), Par01PionShowerModel::Explode(), Par01EMShowerModel::Explode(), G4EquilibriumEvaporator::explosion(), export_G4ThreeVector(), PerspectiveVisAction::ExtendedDraw(), FCALMaterialConsultant::FCALMaterialConsultant(), CLHEP::DoubConv::fill_byte_order(), G4INCL::ElasticChannel::fillFinalState(), CML2PrimaryGenerationAction::fillParticlesContainer(), G4Physics2DVector::FindBinLocation(), G4BinaryCascade::FindFragments(), for(), G4VKinkyStringDecay::FragmentString(), G4Abla::frldm(), G4ArrowModel::G4ArrowModel(), G4BoundingEnvelope::G4BoundingEnvelope(), G4EmCaptureCascade::G4EmCaptureCascade(), G4Expf(), G4gsmate(), G4gspos(), G4gsrotm(), G4Para::G4Para(), G4RandomDirection(), G4fissionEvent::G4SmpWatt(), G4Trap::G4Trap(), G4NuclNuclDiffuseElastic::GammaLogarithm(), G4NuclNuclDiffuseElastic::GammaLogB2n(), G4INCL::Math::gaussianCDF(), CLHEP::RandChiSquare::genChiSquare(), CexmcReimplementedGenbod::Generate(), MedicalBeam::GenerateBeamDirection(), G4NucleiModel::generateModel(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), DMXParticleSource::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), F06PrimaryGeneratorAction::GeneratePrimaries(), PrimaryGeneratorAction1::GeneratePrimaries(), ExUCNPrimaryGeneratorAction::GeneratePrimaries(), IORTPrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPlanePrimaryGeneratorAction::GeneratePrimaries(), FFPrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), PrimaryGenerator::GeneratePrimaryVertex(), CLHEP::HepRotation::getAngleAxis(), G4GDMLWriteDefine::GetAngles(), G4hhElastic::GetAqQ(), ClusterSBPoints::GetBarycenter(), G4hhElastic::GetCofS1(), G4hhElastic::GetCofS2(), G4hhElastic::GetCofS3(), G4NuclNuclDiffuseElastic::GetCoulombElasticXsc(), G4DiffuseElastic::GetCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetCoulombIntegralXsc(), G4DiffuseElastic::GetCoulombIntegralXsc(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), XrayFluoDetectorConstruction::GetDetectorPosition(), G4NuclNuclDiffuseElastic::GetDiffuseElasticSumXsc(), G4DiffuseElastic::GetDiffuseElasticSumXsc(), GVFlashShowerParameterisation::GetEffZ(), G4NuclNuclDiffuseElastic::GetErf(), G4NuclNuclDiffuseElastic::GetErfSer(), G4TwistTubsSide::GetFacets(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), G4HarmonicPolMagField::GetFieldValue(), G4DELPHIMagField::GetFieldValue(), HadrontherapyMagneticField3D::GetFieldValue(), PurgMagTabulatedField3D::GetFieldValue(), G4VScoreWriter::GetIndex(), G4VKinkyStringDecay::GetLightConeGluonZ(), G4QGSMFragmentation::GetLightConeZ(), G4LundStringFragmentation::GetLightConeZ(), G4CutTubs::GetMaxMinZ(), G4QAOLowEnergyLoss::GetOccupationNumber(), G4Paraboloid::GetPointOnSurface(), G4TwistedTubs::GetPointOnSurface(), G4BoundingEnvelope::GetPrismAABB(), G4DiffractiveExcitation::GetQuarkFractionOfKink(), G4OpenInventorXtExaminerViewer::getSceneElements(), CCaloOrganization::getUnitWithMaxEnergy(), G4Trap::GetVertices(), G4EquilibriumEvaporator::goodRemnant(), G4Abla::guet(), G4VhElectronicStoppingPower::HeEffChargeSquare(), G4BraggIonModel::HeEffChargeSquare(), G4GDMLReadSolids::HypeRead(), G4RKFieldIntegrator::Init(), G4NuclNuclDiffuseElastic::InitDynParameters(), G4Abla::initEvapora(), DicomDetectorConstruction::InitialisationOfMaterials(), Materials::Initialise(), G4NucleiModel::initializeCascad(), G4NuclNuclDiffuseElastic::InitParameters(), G4NuclNuclDiffuseElastic::InitParametersGla(), G4hIonEffChargeSquare::IonEffChargeSquare(), G4INCL::NKbToLpiChannel::KaonMomentum(), G4INCL::NKbToNKbChannel::KaonMomentum(), G4INCL::NKbElasticChannel::KaonMomentum(), G4INCL::NpiToLKChannel::KaonMomentum(), G4INCL::NpiToSKChannel::KaonMomentum(), G4INCL::NKbToSpiChannel::KaonMomentum(), lgam(), G03DetectorConstruction::ListOfMaterials(), G02DetectorConstruction::ListOfMaterials(), MyGamma::LnGamma(), PDBlib::Load(), G4LatticeLogical::Load_NMap(), G4RDCompositeEMDataSet::LoadData(), G4BremsstrahlungParameters::LoadData(), G4eIonisationParameters::LoadData(), G4RDBremsstrahlungParameters::LoadData(), G4RDeIonisationParameters::LoadData(), G4CompositeDataSet::LoadData(), G4CompositeEMDataSet::LoadData(), G4CompositeEMDataSet::LoadNonLogData(), G4INCL::Store::loadParticles(), G4OpenInventorXtExaminerViewer::loadRefCoordsCB(), G4OpenInventorXtExaminerViewer::loadViewPts(), G4ReactionProduct::Lorentz(), LXeMainVolume::LXeMainVolume(), G4InuclNuclei::makeNuclearFragment(), MCGIDI_energy_sampleWatt(), G4INCL::KinematicsUtils::momentumInCM(), G4OpenInventorXtExaminerViewer::mouseoverCB(), G4OpenInventorXtExaminerViewer::moveCamera(), nf_amc_z_coefficient(), nf_gammaFunction(), nf_incompleteGammaFunctionComplementary(), G4ShellData::NumberOfShells(), G4RDShellData::NumberOfShells(), GMocrenDataPrimitive< T >::operator+(), operator+(), GMocrenDataPrimitive< T >::operator+=(), operator-(), G4GMocrenFileSceneHandler::Index3D::operator<(), GMocrenDataPrimitive< T >::operator=(), G4GMocrenFileSceneHandler::Index3D::operator==(), CLHEP::operator>>(), HepGeom::operator>>(), G4GDMLReadSolids::ParaRead(), G3EleTable::parse(), G4DNAMillerGreenExcitationModel::PartialCrossSection(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), PG4gsmate(), PG4gsmixt(), PG4gspos(), PG4gsposp(), G4NuclNuclDiffuseElastic::PhaseFar(), G4NuclNuclDiffuseElastic::PhaseNear(), G4GDMLWriteDefine::Position_vectorWrite(), G4SteppingVerbose::PostStepDoItAllDone(), G4ITSteppingVerbose::PostStepDoItAllDone(), G4SteppingVerbose::PostStepDoItOneByOne(), G4ITSteppingVerbose::PostStepDoItOneByOne(), G4RDVCrossSectionHandler::PrintData(), G4VCrossSectionHandler::PrintData(), G4PixeCrossSectionHandler::PrintData(), G4INCL::Store::printParticleConfiguration(), HepGeom::BasicVector3D< T >::pseudoRapidity(), ptwXY_exp_s(), ptwXY_f_integrate(), G4Abla::qrot(), G4DNAWaterDissociationDisplacer::radialDistributionOfProducts(), G4GMocrenIO::retrieveData2(), G4GMocrenIO::retrieveData3(), G4GMocrenIO::retrieveData4(), HepGeom::BasicVector3D< T >::rotate(), HepGeom::BasicVector3D< T >::rotateX(), HepGeom::BasicVector3D< T >::rotateY(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4VEmissionProbability::SampleEnergy(), G4WentzelVIModel::SampleScattering(), G4DNAUeharaScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4RDCompositeEMDataSet::SaveData(), G4CompositeDataSet::SaveData(), G4CompositeEMDataSet::SaveData(), G4OpenInventorXtExaminerViewer::saveRefCoordsCB(), G4OpenInventorXtExaminerViewer::saveRefCoordsOverWriteCB(), G4OpenInventorXtExaminerViewer::saveViewPt(), G4GDMLWriteDefine::Scale_vectorWrite(), SensitiveDetectorHit::SensitiveDetectorHit(), B5DetectorConstruction::SetArmAngle(), ExN04CalorimeterHit::SetCellID(), B5EmCalorimeterHit::SetCellID(), RE05CalorimeterHit::SetCellID(), B5HadCalorimeterHit::SetColumnID(), G4TwistTrapParallelSide::SetCorners(), G4TwistBoxSide::SetCorners(), G4TwistTrapAlphaSide::SetCorners(), G4TwistTrapFlatSide::SetCorners(), G4TwistTubsFlatSide::SetCorners(), G4TwistTubsHypeSide::SetCorners(), G4TwistTubsSide::SetCorners(), F04SimpleSolenoid::SetFringeZ(), CML2Acc1::SetJawAperture(), SensitiveDetectorHit::SetLayerID(), B5DriftChamberHit::SetLayerID(), G4VisCommandsViewerSet::SetNewValue(), G4VisCommandViewerAddCutawayPlane::SetNewValue(), G4VisCommandViewerChangeCutawayPlane::SetNewValue(), G4AdjointSimMessenger::SetNewValue(), G4VisCommandSceneAddText::SetNewValue(), G4ElementaryParticleCollider::setNucleusState(), G4Polycone::SetOriginalParameters(), G4Polyhedra::SetOriginalParameters(), G4Abla::SetParametersG4(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LivermorePolarizedPhotoElectricGDModel::SetPerpendicularVector(), G4LowEnergyPolarizedCompton::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), LXePMTSD::SetPmtPositions(), B5HadCalorimeterHit::SetRowID(), G4FissionLevelDensityParameterINCLXX::setZHigh(), G4FissionLevelDensityParameterINCLXX::setZLow(), F02PrimaryGeneratorAction::SetZVertex(), F01PrimaryGeneratorAction::SetZVertex(), F03PrimaryGeneratorAction::SetZVertex(), F04PrimaryGeneratorAction::SetZvertex(), G3toG4DetectorConstruction::SimpleConstruct(), NeuronLoadDataFile::SingleNeuronSWCfile(), G4OpenInventorXtExaminerViewer::sortViewPts(), G4QGSMFragmentation::SplitEandP(), G4LundStringFragmentation::SplitEandP(), G4OpenInventorXtExaminerViewer::sqrlen(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4hSRIM2000p::StoppingPower(), G4hICRU49He::StoppingPower(), G4hICRU49p::StoppingPower(), G4hZiegler1985p::StoppingPower(), G4hParametrisedLossModel::StoppingPower(), G4BraggModel::StoppingPower(), G4BraggIonModel::StoppingPower(), G4GMocrenIO::storeData2(), G4GMocrenIO::storeData3(), G4GMocrenIO::storeData4(), G4NuclNuclDiffuseElastic::TestAngleTable(), G4DiffuseElastic::TestAngleTable(), HepPolyhedron::Transform(), G4GDMLReadSolids::TrapRead(), G4GDMLReadSolids::TrdRead(), G4PolyPhiFace::Triangulate(), G4GDMLReadSolids::TubeRead(), G4GDMLReadSolids::TwistedboxRead(), G4GDMLReadSolids::TwistedtrapRead(), G4GDMLReadSolids::TwistedtrdRead(), G4Abla::umass(), FCALSteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), DMXEventAction::writePmtHitsToFile().
Double_t Z1 |
advanced/microbeam/plot.C 파일의 264 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4Abla::barrs(), G4ChipsNeutronInelasticXS::CrossSectionLin(), G4Fissioner::deExcite(), G4EquilibriumEvaporator::deExcite(), G4CompetitiveFission::EmittedFragment(), G4RKFieldIntegrator::Erf(), G4GIDI_Misc_channelCompound(), G4PiNuclearCrossSection::GetElementCrossSection(), G4NucleonNuclearCrossSection::GetElementCrossSection(), G4ComponentBarNucleonNucleusXsc::GetElementCrossSection(), G4ChipsNeutronElasticXS::GetPTables(), G4StrawTubeXTRadiator::GetStackFactor(), G4FermiFragmentsPoolVI::Initialise(), G4VXTRenergyLoss::OneInterfaceXTRdEdx(), G4Fissioner::potentialMinimization(), G4AntiNuclElastic::SampleInvariantT(), G4IonCoulombCrossSection::SetScreenRSquare().
Double_t Z2 |
advanced/microbeam/plot.C 파일의 264 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4Abla::barrs(), G4RDGenerator2BN::Calculatedsdkdt(), G4Generator2BN::Calculatedsdkdt(), G4WentzelVIRelModel::ComputeEffectiveMass(), G4ChipsNeutronInelasticXS::CrossSectionLin(), G4Fissioner::deExcite(), G4CompetitiveFission::EmittedFragment(), G4GIDI_Misc_channelCompound(), G4PiNuclearCrossSection::GetElementCrossSection(), G4NucleonNuclearCrossSection::GetElementCrossSection(), G4ComponentBarNucleonNucleusXsc::GetElementCrossSection(), G4ChipsNeutronElasticXS::GetPTables(), G4StrawTubeXTRadiator::GetStackFactor(), G4FermiFragmentsPoolVI::Initialise(), G4EmCorrections::KShellCorrection(), G4EmCorrections::LShellCorrection(), G4VXTRenergyLoss::OneInterfaceXTRdEdx(), G4AntiNuclElastic::SampleInvariantT(), G4EmCorrections::ShellCorrection().
Zc = -1327e3 + 955e3*cos(10*TMath::Pi()/180) |
advanced/microbeam/plot.C 파일의 264 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : for(), G4ParticleHPKallbachMannSyst::SeparationEnergy().
Float_t zVox |
advanced/microbeam/plot.C 파일의 36 번째 라인에서 정의되었습니다.
Double_t zz |
advanced/microbeam/plot.C 파일의 277 번째 라인에서 정의되었습니다.
다음에 의해서 참조됨 : G4Abla::barfit(), G4ReflectedSolid::BoundingLimits(), G4MIRDLiver::Construct(), G4VoxelLeftBreast::Construct(), G4VoxelRightBreast::Construct(), G4MIRDRightKidney::Construct(), G4MIRDThyroid::Construct(), G4MIRDLeftKidney::Construct(), G4MIRDPancreas::Construct(), G4MIRDRibCage::Construct(), G4MIRDUpperSpine::Construct(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), BrachyUserScoreWriter::DumpQuantityToFile(), export_G4RotationMatrix(), export_G4Transform3D(), G4INCL::DeltaProductionChannel::fillFinalState(), G4INCL::ElasticChannel::fillFinalState(), G4BoundingEnvelope::FindScaleFactor(), G4Abla::fissility(), G4gsmate(), CLHEP::RandChiSquare::genChiSquare(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXscNS(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXscPDG(), G4PolyconeSide::GetPointOnFace(), G4Abla::guet(), HepPolyhedronCons::HepPolyhedronCons(), HepPolyhedronEllipsoid::HepPolyhedronEllipsoid(), HepPolyhedronEllipticalCone::HepPolyhedronEllipticalCone(), HepPolyhedronHype::HepPolyhedronHype(), HepPolyhedronParaboloid::HepPolyhedronParaboloid(), HepPolyhedronPgon::HepPolyhedronPgon(), HepPolyhedronSphere::HepPolyhedronSphere(), HepPolyhedronTorus::HepPolyhedronTorus(), G4LivermoreGammaConversionModel::InitialiseProbability(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), HepGeom::operator*(), HepGeom::BasicVector3D< T >::rotate(), G4GoudsmitSaundersonMscModel::SampleMSC(), HadrontherapyDetectorHit::SetEdepAndPosition(), IORTDetectorHit::SetEdepAndPosition(), HepGeom::Normal3D< float >::transform(), HepGeom::Normal3D< double >::transform().