ECCE @ EIC Software
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
plot.C File Reference

Go to the source code of this file.

Functions

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")
 

Variables

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)
 

Function Documentation

c1 cd ( )
c1 cd ( )
c1 cd ( )
c1 cd ( )
c1 cd ( )
c1 cd ( )
c1 cd ( )
c1 cd ( 10  )
c1 cd ( 11  )
c1 cd ( 12  )
c1 cd ( )
c1 cd ( )
c1 Divide ( ,
 
)
h1 Draw ( )
h11 Draw ( "same"  )
ntupleYX Draw ( "Y:X>>hist ,
"vox"  ,
"colz"   
)
hist2 Draw ( "colz"  )
ntupleYXN Draw ( "Y:X>>hist2 ,
"vox"  ,
"colz"   
)
ntupleR Draw ( "X2:Z2"  )
ntuple4 Draw ( "y*0.359060:x*0.359060>>histbis ,
"doseV"  ,
"contz"   
)
histter Draw ( "contz"  )
ntuple4 Draw ( "x*0.359060:(z+1500/0.162810+21)*0.162810>>histter ,
"doseV"  ,
"contz"   
)
TFile f ( "microbeam.root"  )
fclose ( fp  )
h88 Fit ( "gaus"  )
for ( )

Definition at line 281 of file plot.C.

View newest version in sPHENIX GitHub at line 281 of file plot.C

References x, Xc, y, Y1, z, and Zc.

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"   
)
h88 Scale ( scale  )
tChem SetBranchAddress ( "x"  ,
x 
)
tChem SetBranchAddress ( "y"  ,
y 
)
tChem SetBranchAddress ( "z"  ,
z 
)
h1bis SetFillColor ( )
h11 SetFillColor ( )
h10 SetFillColor ( )
h20 SetFillColor ( )
h88 SetFillColor ( )
h1 SetLineColor ( )
h11 SetLineColor ( )
h2 SetLineColor ( )
h20 SetLineColor ( )
h2bis SetLineColor ( )
gaus SetLineColor ( )
gPad SetLogz ( )
gStyle SetOptFit ( )
gStyle SetOptStat ( 0000  )
gStyle SetPalette ( )
gROOT SetStyle ( "Plain"  )
hist SetTitle ( "Cytoplasm intensity on transverse section"  )
hist2 SetTitle ( "Nucleus intensity on transverse section"  )
h2bis SetTitle ( "dE/dx at cell entrance"  )
histbis SetTitle ( "Energy deposit -transverse- (z axis in eV)"  )
histter SetTitle ( "Energy deposit -longitudinal- (z axis in eV)"  )
h77 SetTitle ( "Beam X position on cell"  )
h88 SetTitle ( "Beam Y position on cell"  )
system ( "hadd -O microbeam.root microbeam_*.root"  )
while ( )

Definition at line 54 of file plot.C.

View newest version in sPHENIX GitHub at line 54 of file plot.C

References mat, voxelSizeX, voxelSizeY, and voxelSizeZ.

Variable Documentation

c1 = new TCanvas ("c1","",20,20,1200,900)

Definition at line 27 of file plot.C.

View newest version in sPHENIX GitHub at line 27 of file plot.C

Float_t d

Definition at line 235 of file plot.C.

View newest version in sPHENIX GitHub at line 235 of file plot.C

Float_t dose

Definition at line 35 of file plot.C.

View newest version in sPHENIX GitHub at line 35 of file plot.C

TH1F* h10 = new TH1F("h10bis","Dose distribution in Cytoplasm",100,0.001,.2)
TH1F* h11 = new TH1F("h11 ","",100,1,300)

Definition at line 42 of file plot.C.

View newest version in sPHENIX GitHub at line 42 of file plot.C

Referenced by G4ViewParameters::CatmullRomCubicSplineInterpolation(), G4ErrorSymMatrix::invertCholesky5(), G4ErrorSymMatrix::invertCholesky6(), and plotResults::main().

TH1F* h1bis = new TH1F("h1bis","Dose distribution in Nucleus",100,0.001,1.)

Definition at line 186 of file plot.C.

View newest version in sPHENIX GitHub at line 186 of file plot.C

TH1F* h20 = new TH1F("h20 ","",100,1,300)

Definition at line 45 of file plot.C.

View newest version in sPHENIX GitHub at line 45 of file plot.C

Referenced by G4ErrorSymMatrix::invertCholesky5(), G4ErrorSymMatrix::invertCholesky6(), lufowo(), pyfowo(), Read(), and ReadASCII().

TH1F* h2bis = new TH1F("h2bis","Beam stopping power at cell entrance",200,0,300)

Definition at line 237 of file plot.C.

View newest version in sPHENIX GitHub at line 237 of file plot.C

TH1F* h77 = new TH1F("hx","h1",200,-10,10)

Definition at line 349 of file plot.C.

View newest version in sPHENIX GitHub at line 349 of file plot.C

TH1F* h88 = new TH1F("hy","h1",200,-10,10)

Definition at line 350 of file plot.C.

View newest version in sPHENIX GitHub at line 350 of file plot.C

TH2F* hist = new TH2F("hist","hist",50,-20,20,50,-20,20)
TH2F* hist2 = new TH2F("hist2","hist2",50,-20,20,50,-20,20)

Definition at line 152 of file plot.C.

View newest version in sPHENIX GitHub at line 152 of file plot.C

TH2F* histbis = new TH2F("histbis","histbis",50,-20,20,50,-20,20)

Definition at line 309 of file plot.C.

View newest version in sPHENIX GitHub at line 309 of file plot.C

TH2F* histter = new TH2F("histter","histter",50,-20,20,50,-20,20)

Definition at line 325 of file plot.C.

View newest version in sPHENIX GitHub at line 325 of file plot.C

Float_t mat = 0

Definition at line 38 of file plot.C.

View newest version in sPHENIX GitHub at line 38 of file plot.C

Referenced by G4PixeCrossSectionHandler::ActiveElements(), CCalMaterialFactory::addCCalMaterial(), PHG4SpacalDisplayAction::AddMaterial(), G4GMocrenFileSceneHandler::AddSolid(), BeamLineMagnetDisplayAction::AddVolume(), PHG4HybridHomogeneousCalorimeterDisplayAction::AddVolume(), G4JLeicBeamLineMagnetDisplayAction::AddVolume(), PHG4SectorDisplayAction::AddVolume(), G4JLeicDIRCDisplayAction::AddVolume(), G4JLeicVTXDisplayAction::AddVolume(), PHG4ZDCDisplayAction::AddVolume(), PHG4RICHDisplayAction::AddVolume(), PHG4EPDDisplayAction::AddVolume(), PHG4InttDisplayAction::AddVolume(), PHG4PhenixDisplayAction::AddVolume(), PHG4BbcDisplayAction::AddVolume(), PHG4TpcDisplayAction::AddVolume(), PHG4MvtxDisplayAction::AddVolume(), PHG4TpcEndCapDisplayAction::AddVolume(), PHG4ForwardDualReadoutDisplayAction::AddVolume(), PHG4BarrelEcalDisplayAction::AddVolume(), PHG4CrystalCalorimeterDisplayAction::AddVolume(), PHG4ForwardHcalDisplayAction::AddVolume(), PHG4LFHcalDisplayAction::AddVolume(), PHG4SpacalDisplayAction::AddVolume(), PHG4TTLDisplayAction::AddVolume(), PHG4BackwardHcalDisplayAction::AddVolume(), PHG4ForwardEcalDisplayAction::AddVolume(), G4ElectroVDNuclearModel::ApplyYourself(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_AUTO_TEST_CASE(), G4VDNAModel::BuildApplyToMatVect(), G4PixeCrossSectionHandler::BuildCrossSectionsForMaterials(), G4PixeCrossSectionHandler::BuildForMaterials(), G4NistMaterialBuilder::BuildMaterial(), G4DNAModelInterface::BuildMaterialParticleModelTable(), G4NistManager::BuildMaterialWithNewDensity(), G4RDVCrossSectionHandler::BuildMeanFreePathForMaterials(), G4VCrossSectionHandler::BuildMeanFreePathForMaterials(), G4NistMaterialBuilder::BuildNistMaterial(), G4CrossSectionPairGG::BuildPhysicsTable(), G4NeutronElasticXS::BuildPhysicsTable(), G4NeutronInelasticXS::BuildPhysicsTable(), G4ParticleInelasticXS::BuildPhysicsTable(), G4NeutronCaptureXS::BuildPhysicsTable(), G4SBBremTable::BuildSamplingTables(), G4LossTableBuilder::BuildTableForModel(), G4ElectroVDNuclearModel::CalculateEMVertex(), G4Track::CalculateVelocityForOpticalPhoton(), CCalAMaterial::CCalAMaterial(), CellParameterisation::CellParameterisation(), Acts::VolumeMaterialMapper::checkAndInsert(), 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(), Acts::VolumeMaterialMapper::finalizeMaps(), CCalMaterialFactory::findCCalAMaterial(), CCalMaterialFactory::findCCalMaterial(), CCalMaterialFactory::findElement(), CCalMaterialFactory::findG4Material(), G4NistMaterialBuilder::FindOrBuildMaterial(), G4NistMaterialBuilder::FindOrBuildSimpleMaterial(), G4GDMLWriteDefine::GetAngles(), PHG4GDMLWriteDefine::GetAngles(), RE04TrajectoryPoint::GetAttDefs(), G4CrossSectionDataStore::GetCrossSection(), G4ESTARStopping::GetIndex(), F04Materials::GetMaterial(), WLSMaterials::GetMaterial(), XrayFluoNistMaterials::GetMaterial(), G4Material::GetMaterial(), G4HadronicProcess::GetMicroscopicCrossSection(), G4GoudsmitSaundersonMscModel::GetTransportMeanFreePath(), G4GoudsmitSaundersonMscModel::GetTransportMeanFreePathOnly(), gf2_matrix_times(), G4GSPWACorrections::InitDataPerElement(), G4GSPWACorrections::InitDataPerMaterials(), G4NeutronElectronElXsc::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4ICRU90StoppingData::Initialise(), G4ASTARStopping::Initialise(), G4PSTARStopping::Initialise(), G4PAIPhotModel::Initialise(), G4PAIPhotData::Initialise(), G4PAIModelData::Initialise(), G4PAIModel::Initialise(), G4SeltzerBergerModel::Initialise(), G4HadronXSDataTable::Initialise(), G4LossTableBuilder::InitialiseBaseMaterials(), G4ElasticHadrNucleusHE::InitialiseModel(), G4LivermoreGammaConversionModel::InitialiseProbability(), G4DNAMolecularMaterial::Initialize(), G4SandiaTable::Initialize(), G4GSMottCorrection::InitMCDataPerElement(), G4GSMottCorrection::InitMCDataPerMaterials(), G4HadronicInteraction::IsBlocked(), Acts::materialMapperRZ(), Acts::materialMapperXYZ(), Acts::MaterialProperties::MaterialProperties(), G4ScreenedNuclearRecoil::PostStepDoIt(), G4GammaGeneralProcess::PostStepGetPhysicalInteractionLength(), pyG4Material::Print(), G4NistManager::PrintG4Material(), printHits(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4CrossSectionDataStore::SampleZandA(), G4Region::ScanVolumeTree(), G4ElementSelector::SelectZandA(), DetectorConstruction::SetContainerMaterial(), G4NistManager::SetDensityEffectCalculatorFlag(), DetectorConstruction::SetGasMaterial(), PHG4HcalDetector::SetMaterial(), PHG4HcalSubsystem::SetMaterial(), GFlashHomoShowerParameterisation::SetMaterial(), G4DNASecondOrderReaction::SetReaction(), DetectorConstruction::SetTargetMaterial(), HistoManager::SetTargetMaterial(), G4WentzelVIRelXSection::SetupKinematic(), G4WentzelOKandVIxSection::SetupKinematic(), G4EnergyLossForExtrapolator::SetupKinematics(), G4EmCorrections::SetupKinematics(), G4EmCalculator::SetupMaterial(), Acts::AccumulatedSurfaceMaterial::trackAverage(), EICG4LumiSteppingAction::UserSteppingAction(), Acts::JsonGeometryConverter::volumeMaterialToJson(), while(), and FW::RootMaterialWriter::write().

Int_t ncols =0

Definition at line 52 of file plot.C.

View newest version in sPHENIX GitHub at line 52 of file plot.C

Referenced by CellParameterisation::CellParameterisation().

Int_t nentries = (Int_t)ntuple2->GetEntries()

Definition at line 280 of file plot.C.

View newest version in sPHENIX GitHub at line 280 of file plot.C

Int_t nlines =0

Definition at line 51 of file plot.C.

View newest version in sPHENIX GitHub at line 51 of file plot.C

ntuple0 = (TNtuple*)f.Get("ntuple0")

Definition at line 174 of file plot.C.

View newest version in sPHENIX GitHub at line 174 of file plot.C

ntuple1 = (TNtuple*)f.Get("ntuple1")

Definition at line 175 of file plot.C.

View newest version in sPHENIX GitHub at line 175 of file plot.C

Referenced by plot().

ntuple2 = (TNtuple*)f.Get("ntuple2")

Definition at line 176 of file plot.C.

View newest version in sPHENIX GitHub at line 176 of file plot.C

ntuple3 = (TNtuple*)f.Get("ntuple3")

Definition at line 177 of file plot.C.

View newest version in sPHENIX GitHub at line 177 of file plot.C

ntuple4 = (TNtuple*)f.Get("ntuple4")

Definition at line 178 of file plot.C.

View newest version in sPHENIX GitHub at line 178 of file plot.C

TNtuple* ntupleR = new TNtuple("Rmax","ntuple","Z2:Y2:X2")

Definition at line 275 of file plot.C.

View newest version in sPHENIX GitHub at line 275 of file plot.C

TNtuple* ntupleYX = new TNtuple("CYTOPLASM","ntuple","Y:X:vox")

Definition at line 49 of file plot.C.

View newest version in sPHENIX GitHub at line 49 of file plot.C

TNtuple* ntupleYXN = new TNtuple("NUCLEUS","ntuple","Y:X:vox")

Definition at line 47 of file plot.C.

View newest version in sPHENIX GitHub at line 47 of file plot.C

TNtuple* ntupleZX = new TNtuple("CYTOPLASM","ntuple","Z:X:vox")

Definition at line 48 of file plot.C.

View newest version in sPHENIX GitHub at line 48 of file plot.C

scale = 1/h1bis->Integral()

Definition at line 24 of file plot.C.

View newest version in sPHENIX GitHub at line 24 of file plot.C

Referenced by G4AssemblyVolume::AddPlacedAssembly(), G4AssemblyVolume::AddPlacedVolume(), G4HepRepFileXMLWriter::addPoint(), G4BoundingEnvelope::BoundingBoxVsVoxelLimits(), G4ScaledSolid::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), PHG4mRICHDetector::build_mRICH_wall_eside_proj(), G4VEnergyLossProcess::BuildLambdaTable(), G4VEmProcess::BuildLambdaTable(), G4Voxelizer::BuildVoxelLimits(), G4GMocrenIO::calcDoseDistScale(), G4BoundingEnvelope::CalculateExtent(), G4ExtrudedSolid::CalculateExtent(), FitNewton::GaussianRegGradHessian::calcValGradHessian(), G4Ellipsoid::CheckParameters(), G4ReflectionFactory::CheckScale(), FitNewton::ChiSquareGradHessian::computeCovariance(), FitNewton::GaussianRegGradHessian::computeCovariance(), Run::ComputeFluenceError(), G4INCL::Nucleus::computeOneNucleonRecoilKinematics(), G4PionDecayMakeSpin::DaughterPolarization(), G4ScoringCylinder::Draw(), G4ScoringBox::Draw(), G4ScoringCylinder::DrawColumn(), G4ScoringBox::DrawColumn(), G4GMocrenFileSceneHandler::EndSavingGdd(), TpcSpaceChargeReconstructionHelper::extrapolate_phi1(), FitNewton::NewtonMinimizerGradHessian::findSaddlePoint(), fit_all_update(), SimpleTrack3D::fit_track(), sPHENIXTrackerTpc::fitTrack(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnABoxBoundary(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnASphereBoundary(), HepGeom::Transform3D::getDecomposition(), G4GMocrenIO::getDoseDistMinMax(), ActsFatras::detail::GeneralMixture::getGaussian(), ActsFatras::detail::GeneralMixture::getGaussmix(), G4MultiUnion::GetGlobalVector(), G4MultiUnion::GetLocalVector(), testEventiterator::getNextEvent(), G4Ellipsoid::GetPointOnSurface(), ActsFatras::detail::GeneralMixture::getSemigauss(), G4GMocrenIO::getShortDoseDist(), G4GMocrenIO::getShortDoseDistMinMax(), G4ReflectionFactory::IsReflection(), G4RDShellData::LoadData(), G4ShellData::LoadData(), Acts::makeCurvilinearUnitU(), Acts::MaterialComposition::MaterialComposition(), FitNewton::NewtonMinimizerGradHessian::minimize(), G4GDMLWriteSolids::MultiUnionWrite(), G4GDMLReadStructure::PhysvolRead(), PHG4GDMLWriteStructure::PhysvolWrite(), G4GDMLWriteStructure::PhysvolWrite(), G4ReflectionFactory::Place(), G4LowEnergyCompton::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), c2_factory< float_type >::power_law(), pycba2(), pycbal(), pycrth(), G4RPGTwoCluster::ReactionStage(), c2_factory< float_type >::recip(), G4GDMLReadSolids::ReflectedSolidRead(), remove_bad_hits(), 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(), Acts::MaterialProperties::scaleThickness(), PHRTreeSeeding::set_phi_scale(), PHRTreeSeeding::set_z_scale(), PHHoughSeeding::setBinScale(), G4GMocrenIO::setDoseDistMinMax(), HadrontherapyRBE::SetDoseScale(), PHHoughSeeding::setFitErrorScale(), sPHENIXTrackerTpc::setHitErrorScale(), sPHENIXTracker::setHitErrorScale(), sPHENIXSeedFinder::setHitErrorScale(), G4ScreenedNuclearRecoil::SetMFPScaling(), G4VisCommandSceneAddScale::SetNewValue(), DetectorConstruction::SetRadius(), G4GMocrenIO::setShortDoseDist(), PHHoughSeeding::setup_initial_tracker_object(), PHHoughSeeding::setup_seed_tracker_objects(), PHHoughSeeding::setup_tracker_object(), PHHoughSeeding::setVoteErrorScale(), PHHoughSeeding::setZBinScale(), G4GMocrenIO::storeData2(), G4GMocrenIO::storeData3(), G4GMocrenIO::storeData4(), G4GDMLWriteStructure::TraverseVolumeTree(), and ugeom().

Float_t tmp

Definition at line 35 of file plot.C.

View newest version in sPHENIX GitHub at line 35 of file plot.C

Referenced by PHNodeDump::AddDumpObject(), GammaRayTelPhysicsList::AddPackage(), PhysicsList::AddPackage(), G4VXTRenergyLoss::AngleXTRdEdx(), G4BinaryLightIonReaction::ApplyYourself(), G4ExtrudedSolid::ApproxSurfaceNormal(), boost::atomic_compare_exchange(), nlohmann::basic_json::back(), G4StatMFParameters::Beta(), G4DNASmoluchowskiDiffusion::BoundingBox::BoundingBox(), G4ReflectedSolid::BoundingLimits(), CLHEP::MixMaxRng::Branch(), CLHEP::MixMaxRng::BranchInplace(), G4QGSParticipants::BuildInteractions(), G4ReflectedSolid::CalculateExtent(), CellParameterisation::CellParameterisation(), G4QGSParticipants::CheckKinematics(), G4FTFModel::CheckKinematics(), cmpL(), cmpR(), G4GeomTools::comp_ellint_2(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), oncsEvent::convert(), oncsSubevent::convert(), A_Event::convert(), Packet_A::convert(), CLHEP::MixMaxRng::convert1double(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4DiffractiveExcitation::CreateStrings(), G4StatMFParameters::DBetaDT(), G4BinaryLightIonReaction::DeExciteSpectatorNucleus(), G4StateManager::DeregisterDependent(), G4QGSParticipants::DeterminePartonMomenta(), G4EllipticalTube::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Trd::DistanceToIn(), G4Para::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Tet::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistTubsSide::DistanceToSurface(), dokinematics(), G4LogConsts::dp2uint64(), G4PhysicsListHelper::DumpOrdingParameterTable(), FW::BField::txt::fieldMapperRZ(), FW::BField::txt::fieldMapperXYZ(), 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(), InttDefs::genClusKey(), MvtxDefs::genClusKey(), TpcDefs::genClusKey(), MicromegasDefs::genClusterKey(), generic_16bit_genkey(), generic_32bit_genkey(), generic_32bit_key(), generic_lower_16bit_key(), generic_upper_16bit_key(), InttDefs::genHitKey(), MvtxDefs::genHitKey(), TpcDefs::genHitKey(), MicromegasDefs::genHitSetKey(), TrkrDefs::genHitSetKey(), InttDefs::genHitSetKey(), MvtxDefs::genHitSetKey(), TpcDefs::genHitSetKey(), PHG4CellDefs::get_binning(), PHG4CellDefs::get_detid(), PHG4CellDefs::SpacalBinning::get_etabin(), G4VXTRenergyLoss::GetAngleVector(), PHG4CellContainer::getCells(), MvtxDefs::getChipId(), TrkrDefs::getClusKeyHi(), TrkrDefs::getClusKeyLo(), MvtxDefs::getCol(), InttDefs::getCol(), Acts::cyclic_parameter< T, MIN, MAX >::getDifference(), G4NuclNuclDiffuseElastic::GetErf(), G4NuclNuclDiffuseElastic::GetErfSer(), RE02PSEnergyDeposit::GetIndex(), RE02PSNofStep::GetIndex(), RE02PSPassageCellFlux::GetIndex(), RE02PSCellFlux::GetIndex(), RE02PSFlatSurfaceCurrent::GetIndex(), RE02PSFlatSurfaceFlux::GetIndex(), MakeActsGeometry::getInttKeyFromNode(), InttDefs::getLadderPhiId(), InttDefs::getLadderZId(), TrkrDefs::getLayer(), MakeActsGeometry::getMvtxKeyFromNode(), G4PhysicsListHelper::GetOrdingParameter(), TpcDefs::getPad(), TrkrDefs::getPhiElement(), G4QGSParticipants::GetResiduals(), G4FTFModel::GetResiduals(), MvtxDefs::getRow(), InttDefs::getRow(), TpcDefs::getSectorId(), MicromegasDefs::getSegmentationType(), TpcDefs::getSide(), MvtxDefs::getStaveId(), MicromegasDefs::getStrip(), TpcDefs::getTBin(), MicromegasDefs::getTileId(), TrkrDefs::getTrkrId(), TrkrDefs::getZElement(), G4VCurvedTrajectoryFilter::GimmeThePointsAndForgetThem(), G4ParticleHPElementData::Harmonise(), G4ParticleHPChannel::Harmonise(), PHG4CellDefs::has_binning(), G4FTFModel::Init(), G4DNABornIonisationModel1::Initialise(), G4DNABornIonisationModel2::Initialise(), G4MicroElecInelasticModel::Initialise(), PHG4CylinderSubsystem::InitRunSubsystem(), PHG4BarrelEcalSubsystem::InitRunSubsystem(), PHG4ForwardHcalSubsystem::InitRunSubsystem(), EICG4RPSubsystem::InitRunSubsystem(), EICG4B0Subsystem::InitRunSubsystem(), EICG4B0ECALSubsystem::InitRunSubsystem(), EICG4BwdSubsystem::InitRunSubsystem(), EICG4LumiSubsystem::InitRunSubsystem(), G4EicDircSubsystem::InitRunSubsystem(), G4UIaliasList::List(), MyGamma::LnGamma(), G4ExtrudedSolid::MakeDownFacet(), MakeActsGeometry::makeInttMapPairs(), MakeActsGeometry::makeMvtxMapPairs(), G4StatMFMicroManager::MakePartition(), PHGenFitTrkFitter::MakeSvtxTrack(), MakeActsGeometry::makeTpcMapPairs(), G4ExtrudedSolid::MakeUpFacet(), MarshaledG4String::marshal1(), MarshaledExN04MuonHit::marshal1(), MarshaledExN04TrackerHit::marshal1(), MarshaledG4VHitsCollection::marshal1(), MarshaledG4HitsCollection::marshal1(), MarshaledG4HCofThisEvent::marshal1(), MarshaledExN02TrackerHit::marshal1(), MarshaledExN04CalorimeterHit::marshal1(), MarshaledG4THitsCollection< T >::marshal1(), MarshaledExN04TrackerHit::marshal2(), MarshaledExN04MuonHit::marshal2(), MarshaledG4VHitsCollection::marshal2(), MarshaledExN02TrackerHit::marshal2(), MarshaledExN04CalorimeterHit::marshal2(), MarshaledG4VHitsCollection::marshal3(), MarshaledExN02TrackerHit::marshal3(), MarshaledExN04CalorimeterHit::marshal3(), MarshaledExN02TrackerHit::marshal4(), MarshaledExN04CalorimeterHit::marshal4(), G4ParticleHPVector::Merge(), kdfinder::Helix< T >::momentumAt(), G4Tokenizer::operator()(), PHFieldCleo::PHFieldCleo(), PHG4MvtxHitReco::process_event(), PHHepMCParticleSelectorDecayProductChain::process_event(), PHG4BlockCellReco::process_event(), PHG4CylinderCellReco::process_event(), RawDigitBuilderTTL::process_event(), DumpPHG4CylinderCellContainer::process_Node(), G4GeneratorPrecompoundInterface::PropagateNuclNucl(), kdfinder::TVector< T >::pseudoRapidity(), ptwX_reverse(), ptwXY_scaleOffsetXAndY(), pyct5l(), pyct5m(), pyprep(), pystrf(), Acts::IntegrationTest::readFieldXYZ(), G4PhysicsListHelper::ReadInDefaultOrderingParameter(), G4PhysicsListHelper::ReadOrdingParameterTable(), G4PhysicsListHelper::RegisterProcess(), G4StateManager::RemoveDependent(), G4StatDouble::rms(), G4ParticleHPLabAngularEnergy::Sample(), G4ParticleHPProduct::Sample(), G4QGSParticipants::SamplingNucleonKinematics(), G4FTFModel::SamplingNucleonKinematics(), G4SandiaTable::SandiaSwap(), G4VPartonStringModel::Scatter(), G4DNARevertProbability::SetBoundaries(), G4DiffractiveSplitableHadron::SetFirstParton(), G4BinaryLightIonReaction::SetLighterAsProjectile(), G4ReactionTableMessenger::SetNewValue(), G4ParticleMessenger::SetNewValue(), G4ProcessManager::SetProcessOrderingToSecond(), G4DiffractiveSplitableHadron::SetSecondParton(), G4GenericMessenger::Command::SetUnit(), boost::shared_ptr< TClonesArray >::shared_ptr(), Acts::RadialBounds::shifted(), CLHEP::RandBreitWigner::shootM2(), G4ErrorSymMatrix::similarity(), G4ErrorSymMatrix::similarityT(), G4QGSMSplitableHadron::SoftSplitUp(), G4ExpConsts::sp2uint32(), G4LogConsts::sp2uint32(), G4XTRRegularRadModel::SpectralXTRdEdx(), G4RegularXTRadiator::SpectralXTRdEdx(), G4XTRTransparentRegRadModel::SpectralXTRdEdx(), G4TransparentRegXTRadiator::SpectralXTRdEdx(), XTRTransparentRegRadModel::SpectralXTRdEdx(), G4LundStringFragmentation::SplitLast(), G4DiffractiveSplitableHadron::SplitUp(), PHTimer::test(), G4ExpConsts::uint322sp(), G4LogConsts::uint322sp(), G4ExpConsts::uint642dp(), G4LogConsts::uint642dp(), kdfinder::TVector< T >::unit(), xDataXML_stringTo_double(), xDataXML_stringTo_xDataTOM_Int(), XML_ExternalEntityParserCreate(), and XML_ParserCreateNS().

Float_t vox = 0

Definition at line 38 of file plot.C.

View newest version in sPHENIX GitHub at line 38 of file plot.C

Float_t voxelSizeX

Definition at line 39 of file plot.C.

View newest version in sPHENIX GitHub at line 39 of file plot.C

Referenced by while().

Float_t voxelSizeY

Definition at line 39 of file plot.C.

View newest version in sPHENIX GitHub at line 39 of file plot.C

Referenced by while().

Float_t voxelSizeZ

Definition at line 39 of file plot.C.

View newest version in sPHENIX GitHub at line 39 of file plot.C

Referenced by while().

Float_t X

Definition at line 37 of file plot.C.

View newest version in sPHENIX GitHub at line 37 of file plot.C

Referenced by G4EmCorrections::BarkasCorrection(), G4hImpactIonisation::BarkasTerm(), G4InuclSpecialFunctions::bindingEnergyAsymptotic(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), Acts::AtlasStepper< ConstantBField >::covarianceTransport(), PHSimpleVertexFinder::dcaTwoLines(), G4NonEquilibriumEvaporator::deExcite(), G4EquilibriumEvaporator::deExcite(), G4FissionParameters::DefineParameters(), G4AtimaFluctuations::Dispersion(), Acts::AdaptiveMultiVertexFinder< vfitter_t, sfinder_t >::estimateDeltaZ(), PerspectiveVisAction::ExtendedDraw(), SimpleTrack3D::fit_track(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), G4FPYSamplingOps::G4SampleWatt(), CLHEP::RandBinomial::genBinomial(), G4VXTRenergyLoss::GetComptonPerAtom(), G4ParticleHPThermalScatteringData::GetX(), kdfinder::CircleFit< T >::GradientHessian(), G4Abla::imf(), G4PolarizedComptonCrossSection::Initialize(), G4HETCFragment::IntegrateEmissionProbability(), Rossegger::Kimu(), Rossegger::Limu(), Acts::HelicalTrackLinearizer< propagator_t, propagator_options_t >::linearizeTrack(), md5_process(), kdfinder::TVector< T >::orthogonal(), G4Abla::part_fiss(), G4Fissioner::potentialMinimization(), PHTpcCentralMembraneClusterizer::process_event(), PHG4TruthEventAction::ProcessShowers(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), kdfinder::TVector< T >::pseudoProduct(), and kdfinder::TVector< T >::set().

Double_t x

Definition at line 276 of file plot.C.

View newest version in sPHENIX GitHub at line 276 of file plot.C

Xc = -1295.59e3 - 955e3*sin(10*TMath::Pi()/180)

Definition at line 263 of file plot.C.

View newest version in sPHENIX GitHub at line 263 of file plot.C

Referenced by for(), and BEmcRec::Tower2Global().

Float_t xVox

Definition at line 35 of file plot.C.

View newest version in sPHENIX GitHub at line 35 of file plot.C

Double_t xx

Definition at line 276 of file plot.C.

View newest version in sPHENIX GitHub at line 276 of file plot.C

Double_t y

Definition at line 276 of file plot.C.

View newest version in sPHENIX GitHub at line 276 of file plot.C

Double_t Y1

Definition at line 263 of file plot.C.

View newest version in sPHENIX GitHub at line 263 of file plot.C

Referenced by G4HETCFragment::BetaRand(), for(), and G4Fissioner::potentialMinimization().

Double_t Y2

Definition at line 263 of file plot.C.

View newest version in sPHENIX GitHub at line 263 of file plot.C

Referenced by G4HETCFragment::BetaRand(), and G4Fissioner::potentialMinimization().

Float_t yVox

Definition at line 35 of file plot.C.

View newest version in sPHENIX GitHub at line 35 of file plot.C

Float_t Z

Definition at line 37 of file plot.C.

View newest version in sPHENIX GitHub at line 37 of file plot.C

Referenced by 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(), G4LEnp::ApplyYourself(), G4LEpp::ApplyYourself(), G4LowEGammaNuclearModel::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4ParaFissionModel::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4NeutrinoElectronCcModel::ApplyYourself(), G4NeutrinoElectronNcModel::ApplyYourself(), G4NeutronElectronElModel::ApplyYourself(), G4LEHadronProtonElastic::ApplyYourself(), G4NuMuNucleusCcModel::ApplyYourself(), G4PreCompoundModel::ApplyYourself(), G4LFission::ApplyYourself(), G4MuMinusCapturePrecompound::ApplyYourself(), G4NuMuNucleusNcModel::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(), G4RDAugerData::BuildAugerTransitionTable(), G4AugerData::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(), G4NeutronInelasticXS::BuildPhysicsTable(), G4ParticleInelasticXS::BuildPhysicsTable(), G4NeutronCaptureXS::BuildPhysicsTable(), G4PenelopeBremsstrahlungFS::BuildScaledXSTable(), G4StatMFMicroCanonical::CalcFreeInternalEnergy(), G4GEMProbability::CalcProbability(), G4Radioactivation::CalculateChainsFromParent(), G4RadioactiveDecay::CalculateChainsFromParent(), G4RDGenerator2BN::Calculatedsdkdt(), G4Generator2BN::Calculatedsdkdt(), G4PenelopeBremsstrahlungAngular::CalculateEffectiveZ(), G4MuonVDNuclearModel::CalculateEMVertex(), G4GNASHTransitions::CalculateProbability(), 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(), G4NeutrinoNucleusModel::CoherentPion(), G4VCrossSectionDataSet::ComputeCrossSection(), G4LivermorePolarizedPhotoElectricGDModel::ComputeCrossSectionPerAtom(), G4LivermorePolarizedPhotoElectricModel::ComputeCrossSectionPerAtom(), G4LivermorePhotoElectricModel::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4AnnihiToMuPair::ComputeCrossSectionPerAtom(), G4ComponentBarNucleonNucleusXsc::ComputeCrossSections(), G4ComponentGGHadronNucleusXsc::ComputeCrossSections(), G4ComponentGGNuclNuclXsc::ComputeCrossSections(), G4MuPairProductionModel::ComputeDEDXPerVolume(), G4IonisParamMat::ComputeDensityEffectOnFly(), G4LivermoreBremsstrahlungModel::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(), Acts::AtlasStepper< ConstantBField >::covarianceTransport(), 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(), G4NeutrinoNucleusModel::FermiMomentum(), HadrontherapyMatrix::Fill(), G4ElasticHadrNucleusHE::FillData(), HadrontherapyLet::FillEnergySpectrum(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::fillLists(), G4NeutrinoNucleusModel::FinalBarion(), G4NistElementBuilder::FindElement(), G4IonTable::FindIon(), G4IonTable::FindIonInMaster(), G4NistElementBuilder::FindOrBuildElement(), G4PenelopeIonisationCrossSection::FindShellIDIndex(), G4StatMF::FindTemperatureOfBreakingChannel(), G4FissionBarrier::FissionBarrier(), G4Abla::fissionDistri(), G4CompetitiveFission::FissionKineticEnergy(), fullMaterial(), G4CoulombBarrier::G4CoulombBarrier(), G4DensityEffectCalculator::G4DensityEffectCalculator(), G4DopplerProfile::G4DopplerProfile(), G4GIDI_Misc_Z_A_m_ToName(), G4IonisParamElm::G4IonisParamElm(), G4LevelManager::G4LevelManager(), 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(), G4RDAugerData::GetAugerTransition(), G4AugerData::GetAugerTransition(), G4RDAugerData::GetAugerTransitions(), G4AugerData::GetAugerTransitions(), G4SigmaPlusField::GetBarrier(), G4SigmaMinusField::GetBarrier(), G4AntiProtonField::GetBarrier(), G4KaonMinusField::GetBarrier(), G4KaonPlusField::GetBarrier(), G4PionPlusField::GetBarrier(), G4PionMinusField::GetBarrier(), G4AblaVirtualData::getBeta2(), G4AblaVirtualData::getBeta4(), G4AtomicShells_XDB_EADL::GetBindingEnergy(), G4AtomicShells::GetBindingEnergy(), G4LivermorePhotoElectricModel::GetBindingEnergy(), G4QuasiElRatios::GetChExFactor(), G4ElementData::GetComponentDataByID(), G4VXTRenergyLoss::GetComptonPerAtom(), G4NeutronInelasticCrossSection::GetCrossSection(), G4ParticleHPJENDLHEData::GetCrossSection(), G4CrossSectionDataStore::GetCrossSection(), G4NuclNuclDiffuseElastic::GetDiffuseElasticSumXsc(), G4DiffuseElastic::GetDiffuseElasticSumXsc(), G4AblaVirtualData::getEcnz(), G4NucleonNuclearCrossSection::GetElasticCrossSection(), G4ComponentBarNucleonNucleusXsc::GetElasticCrossSection(), G4ComponentGGNuclNuclXsc::GetElasticGlauberGribov(), G4ComponentGGHadronNucleusXsc::GetElasticGlauberGribov(), G4ElementData::GetElement2DData(), G4NeutronInelasticCrossSection::GetElementCrossSection(), G4NucleonNuclearCrossSection::GetElementCrossSection(), G4HadronInelasticDataSet::GetElementCrossSection(), G4HadronElasticDataSet::GetElementCrossSection(), G4ProtonInelasticCrossSection::GetElementCrossSection(), G4KokoulinMuonNuclearXS::GetElementCrossSection(), G4ChargeExchangeProcess::GetElementCrossSection(), G4IonProtonCrossSection::GetElementCrossSection(), G4NeutronElasticXS::GetElementCrossSection(), G4NeutronInelasticXS::GetElementCrossSection(), G4ParticleInelasticXS::GetElementCrossSection(), G4CrossSectionElastic::GetElementCrossSection(), G4CrossSectionInelastic::GetElementCrossSection(), G4NeutronCaptureXS::GetElementCrossSection(), G4BGGNucleonElasticXS::GetElementCrossSection(), G4BGGNucleonInelasticXS::GetElementCrossSection(), G4BGGPionElasticXS::GetElementCrossSection(), G4BGGPionInelasticXS::GetElementCrossSection(), G4ComponentBarNucleonNucleusXsc::GetElementCrossSection(), G4ElementData::GetElementData(), G4DensityEffectData::GetElementIndex(), G4INCL::ParticleTable::getElementName(), G4CompetitiveFission::GetEmissionProbability(), G4PhotonEvaporation::GetEmissionProbability(), G4BinaryCascade::GetExcitationEnergy(), G4INCL::ParticleTable::getFermiMomentumConstantLight(), G4SigmaPlusField::GetField(), G4KaonZeroField::GetField(), G4SigmaMinusField::GetField(), G4SigmaZeroField::GetField(), G4AntiProtonField::GetField(), G4KaonMinusField::GetField(), G4KaonPlusField::GetField(), G4PionPlusField::GetField(), G4PionZeroField::GetField(), G4PionMinusField::GetField(), G4PairingCorrection::GetFissionPairingCorrection(), HadrontherapyRBE::GetHitAlphaAndBeta(), G4Abla::gethyperbinding(), G4INCL::ParticleTable::getINCLMass(), G4ComponentGGNuclNuclXsc::GetInelasticGlauberGribov(), G4ComponentGGHadronNucleusXsc::GetInelasticGlauberGribov(), XrayFluoHPGeDetectorType::GetInfData(), XrayFluoSiLiDetectorType::GetInfData(), G4IonTable::GetIon(), G4IonTable::GetIonName(), G4NeutronElasticXS::GetIsoCrossSection(), G4NeutronInelasticXS::GetIsoCrossSection(), G4ParticleInelasticXS::GetIsoCrossSection(), G4NeutronCaptureXS::GetIsoCrossSection(), G4BGGNucleonInelasticXS::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(), G4INCL::ParticleTable::getNuclearRadius(), G4IonTable::GetNucleusByEncoding(), G4IonTable::GetNucleusMass(), G4ElementData::GetNumberOfComponents(), G4AtomicShells_XDB_EADL::GetNumberOfElectrons(), G4AtomicShells::GetNumberOfElectrons(), G4AtomicShells_XDB_EADL::GetNumberOfFreeElectrons(), G4AtomicShells::GetNumberOfFreeElectrons(), G4NistElementBuilder::GetNumberOfNistIsotopes(), G4QAOLowEnergyLoss::GetNumberOfShell(), G4AtomicShells_XDB_EADL::GetNumberOfShells(), G4AtomicShells::GetNumberOfShells(), G4ICRU73QOModel::GetNumberOfShells(), G4QAOLowEnergyLoss::GetOccupationNumber(), G4QAOLowEnergyLoss::GetOscillatorEnergy(), G4ICRU73QOModel::GetOscillatorEnergy(), G4AblaVirtualData::getPace2(), G4PairingCorrection::GetPairingCorrection(), G4NuclearLevelData::GetPairingCorrection(), G4FissionProductYieldDist::GetParticleDefinition(), G4NeutronElasticXS::GetPhysicsVector(), G4ProtonInelasticCrossSection::GetProtonCrossSection(), G4INCL::ParticleTable::getRadiusParameter(), G4INCL::HFB::getRadiusParameterHFB(), G4ComponentGGHadronNucleusXsc::GetRatioQE(), G4ComponentGGHadronNucleusXsc::GetRatioSD(), 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_XDB_EADL::GetTotalBindingEnergy(), G4AtomicShells::GetTotalBindingEnergy(), G4NistElementBuilder::GetTotalElectronBindingEnergy(), G4ElementData::GetValueForElement(), G4AblaVirtualData::getVgsld(), G4NistElementBuilder::GetZ(), G4ComponentGGNuclNuclXsc::GetZandACrossSection(), G4SandiaTable::GetZtoA(), G4FermiFragmentsPoolVI::HasChannels(), G4ParticleHP2NAInelasticFS::Init(), G4ParticleHP2NDInelasticFS::Init(), G4ParticleHP2NPInelasticFS::Init(), G4ParticleHPDInelasticFS::Init(), G4ParticleHPHe3InelasticFS::Init(), G4ParticleHPN2PInelasticFS::Init(), G4ParticleHPNDInelasticFS::Init(), G4ParticleHPNHe3InelasticFS::Init(), G4ParticleHPNInelasticFS::Init(), G4ParticleHPNPInelasticFS::Init(), G4ParticleHPNXInelasticFS::Init(), G4ParticleHPPInelasticFS::Init(), G4ParticleHP2PInelasticFS::Init(), G4ParticleHPTInelasticFS::Init(), G4ParticleHPNTInelasticFS::Init(), G4ParticleHPNAInelasticFS::Init(), G4ParticleHPPTInelasticFS::Init(), G4ParticleHP2NInelasticFS::Init(), G4ParticleHPPDInelasticFS::Init(), G4ParticleHP3NPInelasticFS::Init(), G4ParticleHPAInelasticFS::Init(), G4ParticleHP4NInelasticFS::Init(), G4ParticleHP3NInelasticFS::Init(), G4ParticleHP3NAInelasticFS::Init(), G4ParticleHPCaptureFS::Init(), G4ParticleHPElementData::Init(), G4LivermoreRayleighModel::Initialise(), G4LivermoreGammaConversionModelRC::Initialise(), G4LivermoreNuclearGammaConversionModel::Initialise(), G4BoldyshevTripletModel::Initialise(), G4LivermorePolarizedPhotoElectricGDModel::Initialise(), G4LivermorePolarizedGammaConversionModel::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermoreComptonModel::Initialise(), G4LivermorePolarizedPhotoElectricModel::Initialise(), G4LivermorePhotoElectricModel::Initialise(), G4LivermorePolarizedRayleighModel::Initialise(), G4LivermorePolarizedComptonModel::Initialise(), G4JAEAElasticScatteringModel::Initialise(), G4AtomicTransitionManager::Initialise(), G4LivermoreBremsstrahlungModel::Initialise(), G4FermiFragmentsPoolVI::Initialise(), G4SeltzerBergerModel::Initialise(), G4LowEPComptonModel::Initialise(), G4NeutronInelasticXS::Initialise(), G4NeutronCaptureXS::Initialise(), G4NeutronElasticXS::Initialise(), G4ParticleInelasticXS::Initialise(), G4LowEPPolarizedComptonModel::Initialise(), G4NistElementBuilder::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4EmSaturation::InitialiseBirksCoefficient(), G4ElementData::InitialiseForComponent(), G4ElementData::InitialiseForElement(), G4VEmModel::InitialiseForMaterial(), G4PhotonEvaporation::InitialiseLevelManager(), G4ElasticHadrNucleusHE::InitialiseModel(), G4NuclNuclDiffuseElastic::InitialiseOnFly(), G4DiffuseElasticV2::InitialiseOnFly(), G4DiffuseElastic::InitialiseOnFly(), G4LivermoreGammaConversionModel::InitialiseProbability(), G4StatMFMicroCanonical::Initialize(), G4StatMFMacroCanonical::Initialize(), G4StatMFMicroManager::Initialize(), G4WendtFissionFragmentGenerator::InitializeANucleus(), G4NuclNuclDiffuseElastic::InitParameters(), G4NuclNuclDiffuseElastic::InitParametersGla(), G4IonTable::Insert(), G4IonTable::InsertWorker(), G4ComponentBarNucleonNucleusXsc::Interpolate(), G4EmCorrections::IonHighOrderCorrections(), G4NeutrinoElectronCcModel::IsApplicable(), G4NeutrinoElectronNcModel::IsApplicable(), G4NeutronElectronElModel::IsApplicable(), G4NuMuNucleusCcModel::IsApplicable(), G4NuMuNucleusNcModel::IsApplicable(), G4NeutrinoNucleusModel::IsApplicable(), G4RadioactiveDecayBase::IsApplicable(), G4RadioactiveDecay::IsApplicable(), G4NeutronElasticXS::IsoCrossSection(), G4ParticleInelasticXS::IsoCrossSection(), G4NeutronInelasticXS::IsoCrossSection(), G4NeutronCaptureXS::IsoCrossSection(), G4GDMLReadMaterials::IsotopeRead(), G4FermiFragmentsPoolVI::IsPhysical(), G4INCL::ClusterDecay::isStable(), G4EmCorrections::KShellCorrection(), layerMaterial(), G4ShellData::LoadData(), G4RDShellData::LoadData(), G4RDBremsstrahlungParameters::LoadData(), G4BremsstrahlungParameters::LoadData(), G4RDeIonisationParameters::LoadData(), G4eIonisationParameters::LoadData(), G4RDAugerData::LoadData(), G4AugerData::LoadData(), G4RDVCrossSectionHandler::LoadData(), G4VCrossSectionHandler::LoadData(), G4NativeScreenedCoulombCrossSection::LoadData(), G4RadioactiveDecayBase::LoadDecayTable(), G4RadioactiveDecay::LoadDecayTable(), G4VCrossSectionHandler::LoadNonLogData(), G4INCL::Store::loadParticles(), G4RDDopplerProfile::LoadProfile(), G4DopplerProfile::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(), Acts::MaterialProperties::MaterialProperties(), G4GDMLReadMaterials::MaterialRead(), G4NuclearLevelData::MaxLevelEnergy(), G4MuPairProductionModel::MaxSecondaryEnergyForElement(), MCGIDI_particle_getInternalID(), MCGIDI_POP_new(), G4hCoulombScatteringModel::MinPrimaryEnergy(), G4eCoulombScatteringModel::MinPrimaryEnergy(), momentumDistributions(), G4AtomicTransitionManager::NumberOfShells(), G4RDAugerData::NumberOfVacancies(), G4AugerData::NumberOfVacancies(), kdfinder::TVector< T >::orthogonal(), 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(), G4RDBremsstrahlungParameters::PrintData(), G4RDeIonisationParameters::PrintData(), G4eIonisationParameters::PrintData(), G4RDShellData::PrintData(), G4BremsstrahlungParameters::PrintData(), G4RDAugerData::PrintData(), G4AugerData::PrintData(), G4NistElementBuilder::PrintElement(), G4INCL::Store::printParticleConfiguration(), PHTpcCentralMembraneClusterizer::process_event(), HadrontherapyDetectorSD::ProcessHits(), STCyclotronSensitiveTarget::ProcessHits(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), G4GeneratorPrecompoundInterface::Propagate(), G4GeneratorPrecompoundInterface::PropagateNuclNucl(), kdfinder::TVector< T >::pseudoProduct(), G4NuclearRadii::RadiusECS(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4LivermoreRayleighModel::ReadData(), G4BoldyshevTripletModel::ReadData(), G4LivermoreComptonModel::ReadData(), G4LivermoreNuclearGammaConversionModel::ReadData(), G4LivermorePolarizedPhotoElectricGDModel::ReadData(), G4LivermoreGammaConversionModel::ReadData(), G4LivermoreGammaConversionModelRC::ReadData(), G4LivermorePolarizedGammaConversionModel::ReadData(), G4LivermoreBremsstrahlungModel::ReadData(), G4JAEAElasticScatteringModel::ReadData(), G4LivermorePolarizedPhotoElectricModel::ReadData(), G4LivermorePolarizedRayleighModel::ReadData(), G4LivermorePhotoElectricModel::ReadData(), G4SeltzerBergerModel::ReadData(), G4LowEPComptonModel::ReadData(), G4LivermorePolarizedComptonModel::ReadData(), G4LowEPPolarizedComptonModel::ReadData(), G4PenelopeOscillatorManager::ReadElementData(), CCalMaterialFactory::readElements(), G4ParticleHPChannel::Register(), G4DNARuddIonisationExtendedModel::RejectionFunction(), G4IonFluctuations::RelativisticFactor(), G4IonTable::Remove(), ALICEKF::repairCovariance(), G4MuPairProductionModel::RetrieveTables(), FW::RootMaterialDecorator::RootMaterialDecorator(), G4ParticleHPIsotropic::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4ParticleHPLabAngularEnergy::Sample(), G4ParticleHPDiscreteTwoBody::Sample(), G4ParticleHPContAngularPar::Sample(), G4RayleighAngularGenerator::SampleDirection(), G4AntiNuclElastic::SampleInvariantT(), G4ChipsElasticModel::SampleInvariantT(), G4ElasticHadrNucleusHE::SampleInvariantT(), G4NuMuNucleusCcModel::SampleLVkr(), G4NuMuNucleusNcModel::SampleLVkr(), G4LivermorePolarizedPhotoElectricGDModel::SampleSecondaries(), G4XrayRayleighModel::SampleSecondaries(), G4DNARuddIonisationExtendedModel::SampleSecondaries(), G4DNARuddIonisationModel::SampleSecondaries(), G4LivermoreRayleighModel::SampleSecondaries(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4LivermorePolarizedPhotoElectricModel::SampleSecondaries(), G4LivermorePhotoElectricModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4LDMBremModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4PEEffectFluoModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4PAIModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4GammaTransition::SampleTransition(), G4CrossSectionDataStore::SampleZandA(), G4QuasiElasticChannel::Scatter(), G4QuasiElRatios::Scatter(), HistoManager::ScoreNewTrack(), G4ParticleInelasticXS::SelectIsotope(), G4NeutronInelasticXS::SelectIsotope(), G4NeutronElasticXS::SelectIsotope(), G4NeutronCaptureXS::SelectIsotope(), G4RDVCrossSectionHandler::SelectRandomAtom(), G4VCrossSectionHandler::SelectRandomAtom(), G4PixeCrossSectionHandler::SelectRandomAtom(), G4ScreenedCoulombCrossSection::SelectRandomUnweightedTarget(), G4WilsonAblationModel::SelectSecondariesByDefault(), G4ElementSelector::SelectZandA(), kdfinder::TVector< T >::set(), G4AblaVirtualData::setAlpha(), G4IsotopeProperty::SetAtomicNumber(), G4AblaVirtualData::setBeta2(), G4AblaVirtualData::setBeta4(), G4eBremParametrizedModel::SetCurrentElement(), G4VEmissionProbability::SetDecayKinematics(), 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(), G4IonCoulombCrossSection::SetupTarget(), G4WentzelOKandVIxSection::SetupTarget(), G4AblaVirtualData::setVgsld(), G4INCL::Cluster::setZ(), G4EmCorrections::ShellCorrection(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), G4RPGNeutronInelastic::SlowNeutron(), G4RPGProtonInelastic::SlowProton(), G4ExcitationHandler::SortSecondaryFragment(), G4MuPairProductionModel::StoreTables(), G4ePairProduction::StreamProcessInfo(), G4MuPairProduction::StreamProcessInfo(), Acts::SurfaceArrayCreator::surfaceArrayOnDisc(), G4NuclNuclDiffuseElastic::TestAngleTable(), G4DiffuseElastic::TestAngleTable(), G4PolarizedComptonCrossSection::TotalXSection(), G4Channeling::UpdateParameters(), G4NuclearLevelData::UploadNuclearLevelData(), FW::Geant4::MMSteppingAction::UserSteppingAction(), G4RDVCrossSectionHandler::ValueForMaterial(), G4PixeCrossSectionHandler::ValueForMaterial(), G4VCrossSectionHandler::ValueForMaterial(), FW::RootMaterialWriter::write(), G4Pow::Z13(), and G4NuclearLevelData::~G4NuclearLevelData().

Double_t z

Definition at line 276 of file plot.C.

View newest version in sPHENIX GitHub at line 276 of file plot.C

Zc = -1327e3 + 955e3*cos(10*TMath::Pi()/180)

Definition at line 263 of file plot.C.

View newest version in sPHENIX GitHub at line 263 of file plot.C

Referenced by for(), G4ParticleHPKallbachMannSyst::SeparationEnergy(), and BEmcRec::Tower2Global().

Float_t zVox

Definition at line 35 of file plot.C.

View newest version in sPHENIX GitHub at line 35 of file plot.C

Double_t zz

Definition at line 276 of file plot.C.

View newest version in sPHENIX GitHub at line 276 of file plot.C

Referenced by G4Abla::barfit(), G4ReflectedSolid::BoundingLimits(), PHG4mRICHDetector::build_mRICH_sector2(), RMC01AnalysisManager::ComputeMeanEdepAndError(), G4MIRDLiver::Construct(), G4VoxelLeftBreast::Construct(), G4VoxelRightBreast::Construct(), G4MIRDRightKidney::Construct(), G4MIRDLeftKidney::Construct(), G4MIRDThyroid::Construct(), G4MIRDUpperSpine::Construct(), G4MIRDRibCage::Construct(), G4MIRDPancreas::Construct(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), BrachyUserScoreWriter::DumpQuantityToFile(), G4INCL::DeltaProductionChannel::fillFinalState(), G4INCL::ElasticChannel::fillFinalState(), G4BoundingEnvelope::FindScaleFactor(), G4Abla::fissility(), G4gsmate(), CLHEP::RandChiSquare::genChiSquare(), G4PiNuclearCrossSection::GetElementCrossSection(), G4PolyconeSide::GetPointOnFace(), BEmcRec::GetProb(), 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*(), pydisg(), pyhiresd(), pyremn(), pyresd(), HepGeom::BasicVector3D< T >::rotate(), G4GoudsmitSaundersonMscModel::SampleMSC(), HadrontherapyDetectorHit::SetEdepAndPosition(), BEmcRec::SetTowerGeometry(), HepGeom::Normal3D< float >::transform(), HepGeom::Normal3D< double >::transform(), and HelixHough::vote_z().