Geant4  v4-10.4-release
 모두 클래스 네임스페이스들 파일들 함수 변수 타입정의 열거형 타입 열거형 멤버 Friends 매크로 그룹들 페이지들
함수 | 변수
comparison_ascii.C 파일 참조
#include <vector>

이 파일의 소스 코드 페이지로 가기

함수

cout<< "Reading file \" "
<< doseFileExp
<< "\" ... ";Long64_t nlines=ntupleExperimental-> 
ReadFile (doseFileExp,"depthExp:EdepExp")
 
 if (nlines<=0)
 
 printf ("%d Experimental points found\n", nlines)
 
ntupleExperimental SetBranchAddress ("EdepExp",&EdepExp)
 
ntupleExperimental SetBranchAddress ("depthExp",&depthExp)
 
ntupleExperimental GetEntry (0)
 
 for (Int_t l=0;l< nentries;l++)
 
ntupleExperimental Reset ()
 
ntupleExperimental Fill (depthExp, EdepExp)
 
in open (doseFileSim)
 
 if (!in.is_open())
 
TNtupleSim Fill (f1, f2, f3, f4)
 
 while (in.good())
 
in close ()
 
TNtupleSim SetBranchAddress ("dose",&dose)
 
TNtupleSim SetBranchAddress ("iX",&iX)
 
vec_iX clear ()
 
 printf ("%d Simulated points found\n", vec_iX.size())
 
TNtupleSim Fill (iX, 0, 0, dose)
 
TNtupleSim SetMarkerStyle (26)
 
TNtupleSim SetMarkerSize (0.8)
 
ntupleExperimental SetMarkerStyle (4)
 
ntupleExperimental SetMarkerColor (2)
 
ntupleExperimental Draw ("EdepExp:depthExp")
 
TNtupleSim Draw ("dose:iX","","same")
 
leg SetTextSize (0.035)
 
leg SetFillColor (0)
 
leg AddEntry (ntupleExperimental,"Experiment","P")
 
leg AddEntry (TNtupleSim,"Simulation","P")
 
leg Draw ()
 

변수

ifstream in
 
TFile * file = new TFile("Dose.root","RECREATE")
 
TNtuple * ntupleExperimental = new TNtuple("ntupleExperimental","Protons, exp. data", "depthExp:EdepExp")
 
vector< Float_t > vec_dose
 
vector< Float_t > vec_iX
 
TString doseFileExp = "../../../experimentalData/proton/BraggPeak/62MeVInWater.out"
 
Float_t depthExp
 
Float_t EdepExp = vec_dose[l]/normFactor
 
Int_t nentries = (Int_t)ntupleExperimental -> GetEntries()
 
Float_t normFactor = EdepExp
 
TString doseFileSim = "../../../SimulationOutputs/proton/BraggPeak/Dose.out"
 
TNtuple * TNtupleSim = new TNtuple("SimTree","dose from ascii file", "iX:jY:kZ:dose")
 
Char_t n [5]
 
Float_t f1
 
Float_t f2
 
Float_t f3
 
Float_t f4
 
 nlines = 0
 
 do
 
Float_t iX
 
Float_t dose = vec_dose[l]/norm
 
Float_t sumDose = 0.
 
Float_t norm = 0.
 
Int_t oldX = iX
 
TCanvas * c1 = new TCanvas ("c1","c1",200,10,600,400)
 
 leg = new TLegend(0.50,0.60,0.20,0.70)
 

함수 문서화

leg AddEntry ( ntupleExperimental  ,
"Experiment"  ,
"P"   
)
leg AddEntry ( TNtupleSim  ,
"Simulation"  ,
"P"   
)
vec_dose clear ( )
in close ( )
ntupleExperimental Draw ( "EdepExp:depthExp"  )
TNtupleSim Draw ( "dose:iX"  ,
""  ,
"same"   
)
leg Draw ( )
ntupleExperimental Fill ( depthExp  ,
EdepExp   
)
TNtupleSim Fill ( f1  ,
f2  ,
f3  ,
f4   
)
TNtupleSim Fill ( iX  ,
,
,
dose   
)
for ( )

comparison_ascii.C 파일의 32 번째 라인에서 정의되었습니다.

다음을 참조함 : GetEntry().

TNtupleSim GetEntry ( )

다음에 의해서 참조됨 : for().

if ( nlines<=  0)
if ( !in.  is_open())

comparison_ascii.C 파일의 54 번째 라인에서 정의되었습니다.

in open ( doseFileSim  )
printf ( "%d Experimental points found\n ,
nlines   
)
printf ( "%d Simulated points found\n ,
vec_iX.  size() 
)
cout<< "Reading file \" " << doseFileExp << "\" ... "; Long64_t nlines = ntupleExperimental -> ReadFile ( doseFileExp  ,
"depthExp:EdepExp"   
)
TNtupleSim Reset ( )

다음에 의해서 참조됨 : Analysis::Clear().

ntupleExperimental SetBranchAddress ( "EdepExp"  ,
EdepExp 
)
ntupleExperimental SetBranchAddress ( "depthExp"  ,
depthExp 
)
TNtupleSim SetBranchAddress ( "dose"  ,
dose 
)
TNtupleSim SetBranchAddress ( "iX"  ,
iX 
)
leg SetFillColor ( )
ntupleExperimental SetMarkerColor ( )
TNtupleSim SetMarkerSize ( 0.  8)
TNtupleSim SetMarkerStyle ( 26  )
ntupleExperimental SetMarkerStyle ( )
leg SetTextSize ( 0.  035)
while ( in.  good())

변수 문서화

TCanvas* c1 = new TCanvas ("c1","c1",200,10,600,400)

comparison_ascii.C 파일의 113 번째 라인에서 정의되었습니다.

Float_t depthExp

comparison_ascii.C 파일의 23 번째 라인에서 정의되었습니다.

do
초기값:
{
in >> f1 >> f2 >> f3 >> f4
Float_t f4
Float_t f2
Float_t f3
Float_t f1
ifstream in
Definition: comparison.C:7

comparison_ascii.C 파일의 61 번째 라인에서 정의되었습니다.

dose = vec_dose[l]/norm
TString doseFileExp = "../../../experimentalData/proton/BraggPeak/62MeVInWater.out"

comparison_ascii.C 파일의 15 번째 라인에서 정의되었습니다.

TString doseFileSim = "../../../SimulationOutputs/proton/BraggPeak/Dose.out"

comparison_ascii.C 파일의 50 번째 라인에서 정의되었습니다.

EdepExp = vec_dose[l]/normFactor

comparison_ascii.C 파일의 23 번째 라인에서 정의되었습니다.

Float_t f1

comparison_ascii.C 파일의 56 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : G4AtimaEnergyLossModel::Bethek_dedx_e(), G4Physics2DVector::BicubicInterpolation(), braggPeak(), G4DNAPTBAugerModel::CalculAugerEnergyFor(), checkBeam(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4PenelopeAnnihilationModel::ComputeCrossSectionPerElectron(), G4AdjointIonIonisationModel::DiffCrossSectionPerAtomPrimToSecond(), G4AdjointhIonisationModel::DiffCrossSectionPerAtomPrimToSecond(), G4FermiFragmentsPoolVI::Dump(), G4INCL::EtaNElasticChannel::fillFinalState(), G4INCL::EtaNToPiNChannel::fillFinalState(), G4INCL::PiNToEtaChannel::fillFinalState(), CLHEP::HepStat::flatToGaussian(), fragmentAngularDistribution(), fragmentAngularDistributionGM(), fragmentAngularDistributionHistogram(), fragmentEnergy(), fragmentEnergyDistributionDifferentAngles(), fragmentYieldsPlot(), G4Facet::G4Facet(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), G4VXTRenergyLoss::GetComptonPerAtom(), G4MesonAbsorption::GetFinalState(), G4PenelopeGammaConversionModel::GetScreeningFunctions(), G4FermiFragmentsPoolVI::Initialise(), nf_Legendre_from_ptwXY(), G4GammaConversionToMuons::PostStepDoIt(), ptwXY_convolution(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4PenelopeRayleighModel::ReadDataFile(), readExfor(), G4AtimaEnergyLossModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4BetheHeitlerModel::ScreenFunction12(), G4PairProductionRelModel::ScreenFunction12(), G4TauLeptonicDecayChannel::spectrum(), CLHEP::RandLandau::transform().

Float_t f2
Float_t f3
Float_t f4
TFile* file = new TFile("Dose.root","RECREATE")

comparison_ascii.C 파일의 5 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : G4ParticleHPJENDLHEData::BuildPhysicsTable(), G4LowEnergyCompton::BuildPhysicsTable(), G4LowEnergyPolarizedCompton::BuildPhysicsTable(), G4IonStoppingData::BuildPhysicsVector(), G4OpenInventorXtExaminerViewer::createNewVPFileCB(), G4FileUtilities::DeleteFile(), RE02RunAction::EndOfRunAction(), G4IsotopeMagneticMomentTable::G4IsotopeMagneticMomentTable(), G4LEPTSDiffXS::G4LEPTSDiffXS(), G4LEPTSElossDistr::G4LEPTSElossDistr(), G4ParticleHPNames::GetName(), HadrontherapyElectricTabulatedField3D::HadrontherapyElectricTabulatedField3D(), HadrontherapyMagneticField3D::HadrontherapyMagneticField3D(), G4LivermoreComptonModel::Initialise(), G4LivermoreComptonModifiedModel::Initialise(), G4LivermorePolarizedComptonModel::Initialise(), G4LowEPComptonModel::Initialise(), G4LowEPPolarizedComptonModel::Initialise(), G4DopplerProfile::LoadBiggsP(), G4RDDopplerProfile::LoadBiggsP(), G4ShellData::LoadData(), G4RDShellData::LoadData(), G4eIonisationParameters::LoadData(), G4FluoData::LoadData(), G4RDeIonisationParameters::LoadData(), G4RDFluoData::LoadData(), G4AugerData::LoadData(), G4RDAugerData::LoadData(), G4RDVCrossSectionHandler::LoadData(), G4VCrossSectionHandler::LoadData(), XrayFluoDataSet::LoadData(), G4RadioactiveDecayBase::LoadDecayTable(), G4RadioactiveDecay::LoadDecayTable(), G4VCrossSectionHandler::LoadNonLogData(), G4DopplerProfile::LoadProfile(), G4RDDopplerProfile::LoadProfile(), G4OpenInventorXtExaminerViewer::loadRefCoordsCB(), XrayFluoSiLiDetectorType::LoadResponseData(), XrayFluoHPGeDetectorType::LoadResponseData(), G4OpenInventorXtExaminerViewer::loadSceneGraphCB(), G4RDVCrossSectionHandler::LoadShellData(), noise(), G4RootRFileManager::OpenRFile(), G4PersistencyCenter::PrintAll(), ProcessSingleFile(), PurgMagTabulatedField3D::PurgMagTabulatedField3D(), XrayFluoRunAction::ReadData(), G4PenelopeBremsstrahlungAngular::ReadDataFile(), G4PenelopeGammaConversionModel::ReadDataFile(), G4PenelopeBremsstrahlungFS::ReadDataFile(), G4PenelopePhotoElectricModel::ReadDataFile(), G4PenelopeRayleighModel::ReadDataFile(), G4DNAPTBElasticModel::ReadDiffCSFile(), G4DNAPTBIonisationModel::ReadDiffCSFile(), G4PenelopeOscillatorManager::ReadElementData(), CCalVisualisable::readFile(), G4PersistencyManager::Retrieve(), Analysis::Save(), G4OpenInventorXtExaminerViewer::saveRefCoordsCB(), G4OpenInventorXtExaminerViewer::saveSceneGraphCB(), G4VisCommandViewerInterpolate::SetNewValue(), G4PersistencyManager::Store(), TabulatedField3D::TabulatedField3D(), G4OpenInventorXtExaminerViewer::viewPtFileSelectedCB().

ifstream in
초기값:
{
gROOT->Reset()

comparison_ascii.C 파일의 1 번째 라인에서 정의되었습니다.

Float_t iX

comparison_ascii.C 파일의 71 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : MCGIDI_sampling_sampleX_from_pdfOfX().

leg = new TLegend(0.50,0.60,0.20,0.70)

comparison_ascii.C 파일의 131 번째 라인에서 정의되었습니다.

cout<< "Reading file \" " << doseFileSim << "\" ... "; in > n n n n

comparison_ascii.C 파일의 55 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : _MCGIDI_map_findTargetViaPoPIDs2(), _MCGIDI_map_simpleWrite2(), G4EmParameters::ActivateForcedInteraction(), G4EmParameters::ActivateSecondaryBiasing(), G4EmCalculator::ActiveForParticle(), G4ESTARStopping::AddData(), G4UPiNuclearCrossSection::AddDataSet(), G4NistMaterialBuilder::AddElementByWeightFraction(), HistoManager::AddEnergy(), EventAction::AddIonizationEvent(), G4EmConfigurator::AddModels(), G4MoleculeGun::AddMoleculeInCMRepresentation(), G4MoleculeGun::AddMoleculesRandomPositionInBox(), G4Element::AddNaturalIsotopes(), G4MoleculeGun::AddNMolecules(), G4HadronElasticPhysicsXS::AddXSection(), G4ContinuousGainOfEnergy::AlongStepDoIt(), G4NuclNuclDiffuseElastic::AmplitudeGG(), G4NuclNuclDiffuseElastic::AmplitudeGla(), appendAttributeValue(), G4EmBiasingManager::ApplyRangeCut(), G4EmBiasingManager::ApplyRussianRoulette(), G4EmBiasingManager::ApplySecondaryBiasing(), G4EmBiasingManager::ApplySplitting(), G4VFacet::ApplyTranslation(), G4ParticleHPElastic::ApplyYourself(), G4ParticleHPCapture::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ParticleHPFission::ApplyYourself(), G4MuMinusCapturePrecompound::ApplyYourself(), G4ParticleHPThermalScattering::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4ParticleHPInelastic::ApplyYourself(), G4FissLib::ApplyYourself(), G4AnyMethod::ArgType(), Atom::Atom(), G4HadronStoppingProcess::AtRestDoIt(), G4RDAugerTransition::AugerOriginatingShellId(), G4AugerTransition::AugerOriginatingShellId(), G4AugerData::AugerShellId(), G4RDAugerData::AugerShellId(), Histo::Book(), G4WilsonAblationModel::BreakItUp(), G4KDTree::Build(), G4Voxelizer::BuildBoundaries(), G4RDeIonisationCrossSectionHandler::BuildCrossSectionsForMaterials(), G4eIonisationCrossSectionHandler::BuildCrossSectionsForMaterials(), G4LowEnergyIonisation::BuildLossTable(), G4GeometryManager::BuildOptimisations(), G4ChargeExchangeProcess::BuildPhysicsTable(), G4UPiNuclearCrossSection::BuildPhysicsTable(), G4LossTableBuilder::BuildRangeTable(), G4RDVeLowEnergyLoss::BuildRangeVector(), G4hRDEnergyLoss::BuildRangeVector(), G4LossTableBuilder::BuildTableForModel(), G4StatMFMacroMultiplicity::CalcMeanA(), G4StatMFMacroChemicalPotential::CalcMeanZ(), G4AntiNuclElastic::CalculateAm(), G4DiffuseElasticV2::CalculateAm(), G4NuclNuclDiffuseElastic::CalculateAm(), G4DiffuseElastic::CalculateAm(), G4ChipsAntiBaryonInelasticXS::CalculateCrossSection(), G4ChipsProtonInelasticXS::CalculateCrossSection(), G4ChipsKaonMinusInelasticXS::CalculateCrossSection(), G4ChipsHyperonInelasticXS::CalculateCrossSection(), G4ChipsPionMinusInelasticXS::CalculateCrossSection(), G4ChipsKaonPlusInelasticXS::CalculateCrossSection(), G4ChipsNeutronInelasticXS::CalculateCrossSection(), G4ChipsPionPlusInelasticXS::CalculateCrossSection(), CML2ExpVoxels::calculateNormalizedEd(), G4QMDNucleus::CalEnergyAndAngularMomentumInCM(), G4QMDCollision::CalKinematicsOfBinaryCollisions(), G4RPGKMinusInelastic::Cascade(), G4RPGAntiLambdaInelastic::Cascade(), G4RPGAntiProtonInelastic::Cascade(), G4RPGAntiSigmaPlusInelastic::Cascade(), G4RPGSigmaPlusInelastic::Cascade(), G4RPGXiMinusInelastic::Cascade(), G4RPGAntiNeutronInelastic::Cascade(), G4RPGAntiOmegaMinusInelastic::Cascade(), G4RPGAntiSigmaMinusInelastic::Cascade(), G4RPGAntiXiMinusInelastic::Cascade(), G4RPGOmegaMinusInelastic::Cascade(), G4RPGAntiXiZeroInelastic::Cascade(), G4RPGKPlusInelastic::Cascade(), G4RPGKZeroInelastic::Cascade(), G4RPGLambdaInelastic::Cascade(), G4RPGSigmaMinusInelastic::Cascade(), G4RPGXiZeroInelastic::Cascade(), G4RPGAntiKZeroInelastic::Cascade(), G4ViewParameters::CatmullRomCubicSplineInterpolation(), G4ParticleHPThermalScattering::check_E_isoAng(), G4PVParameterised::CheckOverlaps(), G4PVPlacement::CheckOverlaps(), G4GeomTools::CheckSnip(), G4PhysicsConstructorRegistry::Clean(), G4CrossSectionDataSetRegistry::Clean(), G4EmModelManager::Clear(), G4JpegCoder::CodeHuffman(), G4JpegCoder::CodeMCU(), G4GDMLReadMaterials::CompositeRead(), G4eBremParametrizedModel::ComputeBremLoss(), G4eBremsstrahlungRelModel::ComputeBremLoss(), G4LivermoreRayleighModel::ComputeCrossSectionPerAtom(), G4LivermoreGammaConversionModelRC::ComputeCrossSectionPerAtom(), G4LivermoreNuclearGammaConversionModel::ComputeCrossSectionPerAtom(), G4LivermorePolarizedGammaConversionModel::ComputeCrossSectionPerAtom(), G4LivermoreComptonModel::ComputeCrossSectionPerAtom(), G4LivermorePolarizedRayleighModel::ComputeCrossSectionPerAtom(), G4LivermorePolarizedComptonModel::ComputeCrossSectionPerAtom(), G4LowEPComptonModel::ComputeCrossSectionPerAtom(), G4LowEPPolarizedComptonModel::ComputeCrossSectionPerAtom(), G4EmCalculator::ComputeDEDXForCutInRange(), G4LivermoreIonisationModel::ComputeDEDXPerVolume(), G4EmCalculator::ComputeElectronicDEDX(), G4PhysicsVector::ComputeSecDerivatives(), G4PhysicsVector::ComputeSecondDerivatives(), G4eBremParametrizedModel::ComputeXSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeXSectionPerAtom(), ExGflashDetectorConstruction::Construct(), G4OpenInventorXtExaminerViewer::constructListsDialog(), G4NeutronCrossSectionXS::ConstructProcess(), G4OutBitStream::CopyByte(), G4TessellatedSolid::CopyObjects(), G4INCL::CoulombNonRelativistic::coulombDeviation(), G4INCL::Store::countCascading(), G4ReduciblePolygon::Create(), G4OpenInventorXtExaminerViewer::createElementsList(), B01DetectorConstruction::CreateImportanceStore(), G4VTwistedFaceted::CreatePolyhedron(), G4TwistedTubs::CreatePolyhedron(), G4CutTubs::CreatePolyhedron(), G4TessellatedSolid::CreatePolyhedron(), G4TwistedTubs::CreateSurfaces(), G4OpenInventorXtExaminerViewer::createViewerButtons(), B01DetectorConstruction::CreateWeightWindowStore(), B02ImportanceDetectorConstruction::CreateWeightWindowStore(), G4LivermoreIonisationCrossSection::CrossSection(), G4DNAUeharaScreenedRutherfordElasticModel::CrossSectionPerVolume(), G4DNAScreenedRutherfordElasticModel::CrossSectionPerVolume(), csz__huft_build(), csz__Inflate_codes(), csz__Inflate_dynamic(), csz__Inflate_stored(), csz__WriteData(), G4Radioactivation::DecayIt(), G4RadioactiveDecay::DecayIt(), G4LowEnergyIonisation::DeexciteAtom(), GB03DetectorConstruction::DefineMaterials(), RE06DetectorConstruction::DefineMaterials(), ExN03DetectorConstruction::DefineMaterials(), G4EmParameters::DefineRegParamForDeex(), G4EmParameters::DefineRegParamForEM(), G4EmParameters::DefineRegParamForLoss(), G4GeometryManager::DeleteOptimisations(), G4PhysicsConstructorRegistry::DeRegister(), G4CrossSectionDataSetRegistry::DeRegister(), G4LossTableManager::DeRegister(), G4ErrorMatrix::dfact_matrix(), G4ErrorMatrix::dfinv_matrix(), G4OpBoundaryProcess::DielectricMetal(), G4DNARuddIonisationModel::DifferentialCrossSection(), G4EllipticalTube::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4Hype::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4Hype::DistanceToOut(), G4TessellatedSolid::DistanceToOut(), G4QMDMeanField::DoClusterJudgment(), doContent(), G4QMDMeanField::DoPropagation(), G4TDigiCollection< T >::DrawAllDigi(), G4THitsCollection< T >::DrawAllHits(), G4ScoreLogColorMap::DrawColorChartText(), G4VScoreColorMap::DrawColorChartText(), B02Run::DumpAllScorer(), B03Run::DumpAllScorer(), B01Run::DumpAllScorer(), RE02Run::DumpAllScorer(), G4EmModelManager::DumpModelList(), G4Abla::eflmac(), G4Abla::eflmac_profi(), G4GMocrenFileSceneHandler::EndSavingGdd(), G4ecpssrBaseKxsModel::ExpIntFunction(), G4ecpssrBaseLixsModel::ExpIntFunction(), PerspectiveVisAction::ExtendedDraw(), f_alloc_int(), G4QuasiElRatios::FetchElTot(), G4INCL::ClusteringModelIntercomparison::SortedNucleonConfiguration::fill(), CLHEP::DoubConv::fill_byte_order(), G4VEnergyLossProcess::FillSecondariesAlongStep(), G4PhysicsVector::FillSecondDerivatives(), RunAction::FillTallyEdep(), Histo::FillTupleD(), Histo::FillTupleF(), Histo::FillTupleI(), G4VHadronPhysics::FindCaptureProcess(), G4EmCalculator::FindDiscreteProcess(), G4VHadronPhysics::FindElasticProcess(), G4EmCalculator::FindEnLossProcess(), G4VHadronPhysics::FindFissionProcess(), HepTool::Evaluator::findFunction(), G4PhysListUtil::FindInelasticProcess(), G4VHadronPhysics::FindInelasticProcess(), G4VEmProcess::FindLambdaMax(), G4PhysListRegistry::FindLongestMatch(), G4EmCalculator::FindMscProcess(), HepPolyhedron::FindNodeNormal(), HepTool::Evaluator::findVariable(), CLHEP::RandBinomial::fire(), G4TrackLogger::FirstEnterance(), G4GDMLReadMaterials::FractionRead(), G4AugerData::G4AugerData(), G4DCIOentryT< T >::G4DCIOentryT(), G4Element::G4Element(), G4EmElementSelector::G4EmElementSelector(), G4ErrorMatrix::G4ErrorMatrix(), G4Exp(), G4Expf(), G4GIDI_targetMass(), G4gsmate(), G4HadElementSelector::G4HadElementSelector(), G4HCIOentryT< T >::G4HCIOentryT(), G4JpegCoder::G4JpegCoder(), G4KineticTrack::G4KineticTrack(), G4ParticleHPChannelList::G4ParticleHPChannelList(), G4ParticleHPFieldPoint::G4ParticleHPFieldPoint(), G4ParticleHPLegendreStore::G4ParticleHPLegendreStore(), G4ParticleHPPartial::G4ParticleHPPartial(), G4RDAugerData::G4RDAugerData(), G4ReduciblePolygon::G4ReduciblePolygon(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4VXTRenergyLoss::G4VXTRenergyLoss(), GammaFit(), MyGamma::GamSer(), CLHEP::RandBinomial::genBinomial(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), G4ParticleHPThermalScattering::get_secondary_energy_from_E_P_E_isoAng(), G4tgrElementFromIsotopes::GetAbundance(), G4SynchrotronRadiationInMat::GetAngleK(), G4GIDI_target::getChannelIDs(), G4tgrElementFromIsotopes::GetComponent(), G4NuclNuclDiffuseElastic::GetCoulombElasticXsc(), G4DiffuseElastic::GetCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetCoulombIntegralXsc(), G4DiffuseElastic::GetCoulombIntegralXsc(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), CCalDataSet::getCrossSection(), G4eIonisationCrossSectionHandler::GetCrossSectionAboveThresholdForElement(), G4CrossSectionDataSetRegistry::GetCrossSectionDataSet(), G4SynchrotronRadiationInMat::GetEnergyProbSR(), G4NuclNuclDiffuseElastic::GetErfComp(), G4NuclNuclDiffuseElastic::GetErfSer(), HepPolyhedron::GetFacet(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), G4DELPHIMagField::GetFieldValue(), G4GIDI_target::getFinalState(), G4EMDissociationSpectrum::GetGeneralE1Spectrum(), G4EMDissociationSpectrum::GetGeneralE2Spectrum(), G4SynchrotronRadiationInMat::GetIntProbSR(), G4QAOLowEnergyLoss::GetL0(), G4ICRU73QOModel::GetL0(), G4QAOLowEnergyLoss::GetL1(), G4ICRU73QOModel::GetL1(), G4QAOLowEnergyLoss::GetL2(), G4ICRU73QOModel::GetL2(), G4LogConsts::getMantExponent(), G4LogConsts::getMantExponentf(), CML2ExpVoxels::getMaxNumberOfEvents(), CML2ExpVoxels::getMinNumberOfEvents(), G4MultiNavigator::GetNavigator(), G4PathFinder::GetNavigator(), G4ITMultiNavigator::GetNavigator(), G4ITPathFinder::GetNavigator(), HepPolyhedron::GetNextFacet(), G4MCTSimEvent::GetNofStoredParticles(), G4MCTSimEvent::GetNofStoredVertices(), G4RPGInelastic::GetNormalizationConstant(), G4StackManager::GetNTotalTrack(), G4DCofThisEvent::GetNumberOfCollections(), G4HCofThisEvent::GetNumberOfCollections(), G4QMDMeanField::GetPotential(), G4QuasiElRatios::GetQF2IN_Ratio(), G4PhysListFactory::GetReferencePhysList(), G4QMDMeanField::GetTotalPotential(), G4AllocatorPool::Grow(), G4Abla::gser(), G4ParticleHPElementData::Harmonise(), G4ParticleHPChannel::Harmonise(), HepPolyhedronHype::HepPolyhedronHype(), HepPolyhedronParaboloid::HepPolyhedronParaboloid(), G4GIDI_target::init(), G4ParticleHPAngularP::Init(), G4Abla::initEvapora(), G4mplIonisationModel::Initialise(), G4mplIonisationWithDeltaModel::Initialise(), G4PAIPhotModel::Initialise(), G4PAIPhotData::Initialise(), G4WentzelVIModel::Initialise(), G4PAIModelData::Initialise(), G4PAIModel::Initialise(), G4EmModelManager::Initialise(), G4ElementData::InitialiseForComponent(), G4VEmModel::InitialiseForMaterial(), CCalEventAction::initialize(), G4ParticleHPFieldPoint::InitY(), G4QMDSystem::InsertParticipant(), G4MultiUnion::InsideWithExclusion(), G4ElasticHadrNucleusHE::InterpolateHN(), G4GeomTools::IsConvex(), G4PhysListFactory::IsReferencePhysList(), G4CrossSectionPatch::IsValid(), G4CrossSectionComposite::IsValid(), G4PolyhedraSide::LineHitsSegments(), G4ShellData::LoadData(), G4RDShellData::LoadData(), G4FluoData::LoadData(), G4RDFluoData::LoadData(), G4AugerData::LoadData(), G4RDAugerData::LoadData(), G4RegionModels::LowEdgeEnergy(), G4Abla::lpoly(), G4JpegCoder::makeYCC(), G4INCL::CoulombDistortion::maxImpactParameter(), MCGIDI_angular_parseFromTOM(), MCGIDI_energy_parseMadlandNixFromTOM(), MCGIDI_KalbachMann_parseFromTOM2(), MCGIDI_map_readFile(), MCGIDI_map_toXMLString(), MCGIDI_misc_getAbsPath(), MCGIDI_misc_symbolToZ(), MCGIDI_outputChannel_parseFromTOM(), MCGIDI_particleMass_AMU(), MCGIDI_product_parsePolynomialMultiplicity(), MCGIDI_target_heated_read(), G4ParticleHPVector::Merge(), G4INCL::CoulombNonRelativistic::minimumDistance(), G4GDMLReadMaterials::MixtureRead(), G4RegionModels::ModelIndex(), nf_amc_log_factorial(), nf_exponentialIntegral(), nf_Legendre_from_ptwXY(), nf_Legendre_GaussianQuadrature(), nf_Legendre_to_ptwXY(), G4AntiNeutronAnnihilationAtRest::NFac(), G4AugerData::NumberOfAuger(), G4RDAugerData::NumberOfAuger(), G4RDVCrossSectionHandler::NumberOfComponents(), G4VCrossSectionHandler::NumberOfComponents(), G4PixeCrossSectionHandler::NumberOfComponents(), G4DopplerProfile::NumberOfProfiles(), G4RDDopplerProfile::NumberOfProfiles(), G4RDAtomicTransitionManager::NumberOfReachableAugerShells(), G4ShellData::NumberOfShells(), G4RDShellData::NumberOfShells(), G4FluoData::NumberOfTransitions(), G4RDFluoData::NumberOfTransitions(), G4AugerData::NumberOfTransitions(), G4RDAugerData::NumberOfTransitions(), G4ErrorMatrix::operator+=(), G4ErrorMatrix::operator-=(), G4ErrorMatrix::operator=(), G4TrajectoryContainer::operator[](), G4BremsstrahlungParameters::ParameterC(), G4RDBremsstrahlungParameters::ParameterC(), G4INCL::ParticleEntryChannel::particleEnters(), HepGeom::Plane3D< G4double >::Plane3D(), G4StokesVector::PolError(), G4GeomTools::PolygonArea(), G4GeomTools::PolygonAreaNormal(), poolCopyStringN(), PoPs_particleLoadInfo(), PoPs_particleMass_AMU(), PoPs_unitConversionRatio(), G4OpenInventorXtExaminerViewer::popUpFileSelDialog(), G4PersistencyCenterMessenger::PopWord(), G4VTransitionRadiation::PostStepDoIt(), G4Pow::powN(), G4EmConfigurator::PrepareModels(), G4VMultipleScattering::PreparePhysicsTable(), G4VEmProcess::PreparePhysicsTable(), G4VEnergyLossProcess::PreparePhysicsTable(), G4INCL::InterpolationTable::print(), G4TDigiCollection< T >::PrintAllDigi(), G4THitsCollection< T >::PrintAllHits(), G4PhysicsConstructorRegistry::PrintAvailablePhysicsConstructors(), G4PhysListRegistry::PrintAvailablePhysLists(), G4MuElecCrossSectionDataSet::PrintData(), G4MicroElecCrossSectionDataSet::PrintData(), G4CrossSectionDataSet::PrintData(), G4DNACrossSectionDataSet::PrintData(), G4CompositeDataSet::PrintData(), G4RDCompositeEMDataSet::PrintData(), G4RDShellEMDataSet::PrintData(), G4ShellEMDataSet::PrintData(), G4CompositeEMDataSet::PrintData(), G4PixeShellDataSet::PrintData(), G4DNAMolecularReactionTable::PrintTable(), G4LivermoreIonisationCrossSection::Probabilities(), G4PenelopeIonisationCrossSection::Probabilities(), LXePMTSD::ProcessHits_constStep(), ptwX_deletePoints(), ptwX_slice(), ptwXY_binary_ptwXY(), ptwXY_clip(), ptwXY_convolution(), ptwXY_createFromFunction(), ptwXY_createGaussianCenteredSigma1(), ptwXY_deletePoints(), ptwXY_div_ptwXY(), ptwXY_div_ptwXY_forFlats(), ptwXY_f_integrate(), ptwXY_flatInterpolationToLinear(), ptwXY_fromUnitbase(), ptwXY_getXArray(), ptwXY_getYMax(), ptwXY_getYMin(), ptwXY_integrate(), ptwXY_integrateWithWeight_sqrt_x(), ptwXY_integrateWithWeight_x(), ptwXY_intersectionWith_ptwX(), ptwXY_mergeClosePoints(), ptwXY_mergeFrom(), ptwXY_mul2_ptwXY(), ptwXY_showInteralStructure(), ptwXY_slice(), ptwXY_toUnitbase(), ptwXY_union(), ptwXY_valueTo_ptwXY(), ptwXY_xSlice(), G4Abla::qrot(), G4MuonDecayChannelWithSpin::R_c(), G4DNADingfelderChargeIncreaseModel::RandomSelect(), G4DNADingfelderChargeDecreaseModel::RandomSelect(), G4DNABornExcitationModel1::RandomSelect(), G4DNABornExcitationModel2::RandomSelect(), G4DNAEmfietzoglouExcitationModel::RandomSelect(), G4DNACPA100ExcitationModel::RandomSelect(), G4MuElecInelasticModel::RandomSelect(), G4DNABornIonisationModel2::RandomSelect(), G4DNARuddIonisationModel::RandomSelect(), G4DNARuddIonisationExtendedModel::RandomSelect(), G4DNABornIonisationModel1::RandomSelect(), G4MicroElecInelasticModel::RandomSelect(), G4DNACPA100IonisationModel::RandomSelect(), G4DNAEmfietzoglouIonisationModel::RandomSelect(), G4VDNAModel::RandomSelectShell(), G4ParticleHPThermalScattering::readACoherentFSDATA(), G4ParticleHPThermalScattering::readAnE_isoAng(), G4ParticleHPThermalScattering::readAnIncoherentFSDATA(), G4ParticleHPThermalScattering::readAnInelasticFSDATA(), G4PhysicsConstructorRegistry::Register(), G4CrossSectionDataSetRegistry::Register(), G4LossTableManager::Register(), G4ParticleHPFastLegendre::regularEvaluate(), G4ParticleHPFastLegendre::regularIntegrate(), HepTool::Evaluator::removeFunction(), HepTool::Evaluator::removeVariable(), G4AllocatorPool::Reset(), G4EmDataHandler::RetrievePhysicsTable(), G4VEmProcess::RetrievePhysicsTable(), G4VEnergyLossProcess::RetrieveTable(), G4DeltaAngle::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4BohrFluctuations::SampleFluctuations(), G4AntiNuclElastic::SampleInvariantT(), G4DNADingfelderChargeDecreaseModel::SampleSecondaries(), G4DNADingfelderChargeIncreaseModel::SampleSecondaries(), G4RDShellEMDataSet::SaveData(), G4MuElecCrossSectionDataSet::SaveData(), G4MicroElecCrossSectionDataSet::SaveData(), G4ShellEMDataSet::SaveData(), G4DNACrossSectionDataSet::SaveData(), G4CrossSectionDataSet::SaveData(), G4OpenInventorXtExaminerViewer::saveRefCoordsDialogCB(), G4OpenInventorXtExaminerViewer::saveSceneGraphDialogCB(), G4OpenInventorXtExaminerViewer::saveViewPtCB(), G4PhysicsVector::ScaleVector(), G4DNAScreenedRutherfordElasticModel::ScreenedRutherfordRandomizeCosTheta(), G4DNAUeharaScreenedRutherfordElasticModel::ScreenedRutherfordRandomizeCosTheta(), G4VEmModel::SelectRandomAtom(), G4VEnergyLossProcess::SetCSDARangeTable(), G4VEnergyLossProcess::SetDEDXBinning(), G4VEnergyLossProcess::SetDEDXTable(), G4VAtomDeexcitation::SetDeexcitationActiveRegion(), G4DeexPrecoParameters::SetDeexModelType(), G4EqEMFieldWithEDM::SetEta(), G4MCTEvent::SetEventNumber(), setItem(), G4VEmProcess::SetLambdaBinning(), G4VEnergyLossProcess::SetLambdaTable(), G4LivermorePolarizedPhotoElectricGDModel::SetLimitNumberOfShells(), G4LivermorePolarizedPhotoElectricModel::SetLimitNumberOfShells(), G4LivermorePhotoElectricModel::SetLimitNumberOfShells(), G4INCL::Config::setMaxNumberMultipions(), G4DeexPrecoParameters::SetMinAForPreco(), G4DeexPrecoParameters::SetMinZForPreco(), LXeDetectorConstruction::SetNFibers(), G4AdjointSimManager::SetNormalisationMode(), G4ParticleHPLegendreStore::SetNPoints(), G4INCL::Particle::setNumberOfCollisions(), G4INCL::Particle::setNumberOfDecays(), HepPolyhedron::SetNumberOfRotationSteps(), G4MTRunManager::SetNumberOfThreads(), G4LivermorePolarizedGammaConversionModel::SetPhi(), G4MTRunManager::SetPinAffinity(), LXePMTHit::SetPMTNumber(), G4DeexPrecoParameters::SetPrecoModelType(), G4EmParameters::SetProcessBiasingFactor(), CLHEP::NonRandomEngine::setRandomSequence(), CLHEP::HepJamesRandom::setSeed(), G4QMDMeanField::SetSystem(), G4DeexPrecoParameters::SetTwoJMAX(), G4MCTSimVertex::SetVolumeNumber(), G4ShellData::ShellId(), G4RDShellData::ShellId(), G4INCL::Random::shootInteger(), G4ErrorSymMatrix::similarity(), G4ErrorSymMatrix::similarityT(), smr_allocateCopyStringN(), smr_numberOfReports(), smr_vallocateFormatMessage(), G4RDFluoData::StartShellEnergy(), G4FluoData::StartShellEnergy(), G4FluoData::StartShellId(), G4RDFluoData::StartShellId(), G4AugerData::StartShellId(), G4RDAugerData::StartShellId(), G4FluoData::StartShellProb(), G4RDFluoData::StartShellProb(), storeAtts(), IORTMatrix::StoreDoseFluenceAscii(), HadrontherapyMatrix::StoreDoseFluenceAscii(), IORTMatrix::StoreDoseFluenceRoot(), storeEntityValue(), IORTMatrix::StoreMatrix(), HadrontherapyMatrix::StoreMatrix(), G4VFacet::StreamInfo(), G4Paraboloid::SurfaceNormal(), G4TessellatedSolid::SurfaceNormal(), HepGeom::Plane3D< G4double >::transform(), G4PolyPhiFace::Triangulate(), G4GeomTools::TriangulatePolygon(), unknown_toUtf8(), G4ProductionCutsTable::UpdateCoupleTable(), utf8_toUtf16(), G4RDFluoData::VacancyId(), G4FluoData::VacancyId(), G4AugerData::VacancyId(), G4RDAugerData::VacancyId(), G4PhysicalVolumeModel::VisitGeometryAndGetVisReps(), w6j1(), G4OpenInventorXtExaminerViewer::warningMsgDialog(), G4PartialWidthTable::Width(), G4RootFileManager::WriteFile(), xDataTOM_getLinksElement2(), xDataTOM_getLinksElement3(), xDataTOM_numberOfElementsByName(), xDataTOME_getOneElementByName(), xDataTOMMisc_getAbsPath(), xDataXML_addElementToRoot(), xDataXML_axesToTOM(), xDataXML_getElementsByTagName(), xDataXML_importFile2(), xDataXML_numberOfElementsByTagName(), xDataXML_stringTo_double(), xDataXML_stringTo_xDataTOM_Int(), G4ElementData::~G4ElementData(), G4IonBinaryCascadePhysics::~G4IonBinaryCascadePhysics(), G4IonINCLXXPhysics::~G4IonINCLXXPhysics(), G4IonQMDPhysics::~G4IonQMDPhysics(), G4PAIModelData::~G4PAIModelData(), G4PAIPhotData::~G4PAIPhotData(), G4PixeCrossSectionHandler::~G4PixeCrossSectionHandler(), G4RDVCrossSectionHandler::~G4RDVCrossSectionHandler(), G4VCrossSectionHandler::~G4VCrossSectionHandler(), G4VHadronPhysics::~G4VHadronPhysics().

nentries = (Int_t)ntupleExperimental -> GetEntries()

comparison_ascii.C 파일의 29 번째 라인에서 정의되었습니다.

nlines = 0
norm = 0.

comparison_ascii.C 파일의 71 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : G4CutTubs::ApproxSurfaceNormal(), G4Torus::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4Cons::ApproxSurfaceNormal(), G4Sphere::ApproxSurfaceNormal(), G4CutTubs::BoundingLimits(), G4VPhononProcess::ChoosePolarization(), CCalMaterial::closeMaterial(), G4WentzelVIRelModel::ComputeEffectiveMass(), G4IonisParamMat::ComputeIonParameters(), G4ExtrudedSolid::ComputeLateralPlanes(), G4BoundingEnvelope::CreateListOfPlanes(), G4eeCrossSections::CrossSection2Kcharged(), G4eeCrossSections::CrossSection2Kneutral(), G4eeCrossSections::CrossSection2pi(), G4eeCrossSections::CrossSection3pi(), G4eeCrossSections::CrossSectionEtaG(), G4eeCrossSections::CrossSectionPi0G(), G4AngularDistribution::DifferentialCrossSection(), G4Ellipsoid::DistanceToIn(), G4Ellipsoid::DistanceToOut(), G4INCL::NKbToLpiChannel::fillFinalState(), G4INCL::NKbToNKbChannel::fillFinalState(), G4INCL::NKbToSpiChannel::fillFinalState(), G4INCL::NKElasticChannel::fillFinalState(), G4INCL::NKToNKChannel::fillFinalState(), G4INCL::NpiToLKChannel::fillFinalState(), G4INCL::NpiToSKChannel::fillFinalState(), Run::FillPerEvent(), G4ExitNormal::G4ExitNormal(), G4PolyPhiFace::G4PolyPhiFace(), G4GeneralParticleSource::GeneratePrimaryVertex(), G4Nucleus::GetBiasedThermalNucleus(), G4INCL::Particle::getCosRPAngle(), CLHEP::HepLorentzVector::howParallel(), G4EmSaturation::InitialiseBirksCoefficient(), G4PolyhedraSide::Inside(), G4hIonEffChargeSquare::IonEffChargeSquare(), CLHEP::HepLorentzVector::isParallel(), G4INCL::NKbElasticChannel::KaonMomentum(), MCGIDI_angular_parseFromTOM(), MCGIDI_angularEnergy_parsePointwiseFromTOM(), MCGIDI_energy_parseGeneralEvaporationFromTOM(), MCGIDI_energy_parseMadlandNixFromTOM(), MCGIDI_energy_parseNBodyPhaseSpaceFromTOM(), MCGIDI_energyAngular_linear_parseFromTOM(), MCGIDI_fromTOM_pdfOfX(), MCGIDI_fromTOM_pdfsOfXGivenW(), MCGIDI_KalbachMann_parseFromTOM2(), MCGIDI_LLNL_angularEnergy_parsePointwiseFromTOM(), MCGIDI_product_sampleMultiplicity(), nf_Legendre_normalize(), G4PolyhedraSide::Normal(), G4LevelReader::NormalizedICCProbability(), G4GenericTrap::NormalToPlane(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), CLHEP::HepBoost::print(), G4UCNMicroRoughnessHelper::S2(), G4GenericTrap::SafetyToFace(), G4ParticleHPLegendreStore::Sample(), G4eeTo3PiModel::SampleSecondaries(), G4NuclNuclDiffuseElastic::SampleThetaCMS(), G4DiffuseElastic::SampleThetaCMS(), RunAction::SaveHisto(), CLHEP::HepLorentzRotation::set(), G4LogicalCrystalVolume::SetMillerOrientation(), G4EmCorrections::ShellCorrection(), G4EllipticalTube::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4Box::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Sphere::SurfaceNormal().

Float_t normFactor = EdepExp

comparison_ascii.C 파일의 31 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : for(), G4PenelopeCrossSection::NormalizeShellCrossSections().

TNtuple* ntupleExperimental = new TNtuple("ntupleExperimental","Protons, exp. data", "depthExp:EdepExp")

comparison_ascii.C 파일의 11 번째 라인에서 정의되었습니다.

Int_t oldX = iX

comparison_ascii.C 파일의 79 번째 라인에서 정의되었습니다.

Float_t sumDose = 0.

comparison_ascii.C 파일의 71 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : B3bRunAction::EndOfRunAction().

TNtuple* TNtupleSim = new TNtuple("SimTree","dose from ascii file", "iX:jY:kZ:dose")

comparison_ascii.C 파일의 51 번째 라인에서 정의되었습니다.

vector<Float_t> vec_dose

comparison_ascii.C 파일의 13 번째 라인에서 정의되었습니다.

vector<Float_t> vec_iX

comparison_ascii.C 파일의 13 번째 라인에서 정의되었습니다.