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) |
c1 cd | ( | 1 | ) |
c1 cd | ( | 5 | ) |
c1 cd | ( | 7 | ) |
c1 cd | ( | 3 | ) |
c1 cd | ( | 2 | ) |
c1 cd | ( | 6 | ) |
c1 cd | ( | 9 | ) |
c1 cd | ( | 10 | ) |
c1 cd | ( | 11 | ) |
c1 cd | ( | 12 | ) |
c1 cd | ( | 4 | ) |
c1 cd | ( | 8 | ) |
c1 Divide | ( | 4 | , |
3 | |||
) |
h1 Draw | ( | ) |
h11 Draw | ( | "same" | ) |
hist Draw | ( | "colz" | ) |
ntupleR Draw | ( | "X2:Z2" | ) |
histter Draw | ( | "contz" | ) |
TFile f | ( | "microbeam.root" | ) |
h88 Fit | ( | "gaus" | ) |
for | ( | ) |
Definition at line 282 of file plot.C.
References c1, std::cos(), MECModelEnuComparisons::i, std::sin(), x, Xc, y, Y1, z, and Zc.
h1 GetXaxis | ( | ) | -> SetLabelSize(0.025) |
Definition at line 84 of file plot_lowE_sig_spread_genie.C.
h1 GetYaxis | ( | ) | -> SetLabelSize(0.025) |
hist GetZaxis | ( | ) | -> SetLabelSize(0.025) |
ntuple3 Project | ( | "h1bis" | , |
"doseN" | |||
) |
ntuple3 Project | ( | "h10bis" | , |
"doseC" | |||
) |
ntuple0 Project | ( | "h2bis" | , |
"sp" | |||
) |
ntuple1 Project | ( | "hx" | , |
"x" | |||
) |
ntuple1 Project | ( | "hy" | , |
"y" | |||
) |
ntuple2 SetBranchAddress | ( | "x" | , |
& | x | ||
) |
ntuple2 SetBranchAddress | ( | "y" | , |
& | y | ||
) |
ntuple2 SetBranchAddress | ( | "z" | , |
& | z | ||
) |
h1 SetFillColor | ( | 3 | ) |
h11 SetFillColor | ( | 8 | ) |
h10 SetFillColor | ( | 2 | ) |
h20 SetFillColor | ( | 5 | ) |
h88 SetFillColor | ( | 4 | ) |
h1 SetLineColor | ( | 3 | ) |
h11 SetLineColor | ( | 8 | ) |
h2 SetLineColor | ( | 2 | ) |
h20 SetLineColor | ( | 5 | ) |
h2bis SetLineColor | ( | 4 | ) |
gaus SetLineColor | ( | 6 | ) |
gPad SetLogz | ( | ) |
gStyle SetOptFit | ( | ) |
gStyle SetOptStat | ( | 0000 | ) |
gStyle SetPalette | ( | 1 | ) |
Referenced by DrawPlots(), and genie::utils::style::SetDefaultStyle().
gROOT SetStyle | ( | "Plain" | ) |
hist SetTitle | ( | "Cytoplasm intensity on transverse section" | ) |
hist2 SetTitle | ( | "Nucleus intensity on transverse section" | ) |
system | ( | "rm -rf microbeam.root" | ) |
Referenced by dbutils::Krb5::checkTicket(), create_test_file(), ana::SAMQuerySource::EnsureDataset(), ana::SAMQuerySource::EnsureSnapshot(), ana::FileListSource::FileListSource(), ana::gdb_backtrace(), generate_fd_fake_events(), novadaq::ProcessUtils::getChildProcessIds(), dbutils::Krb5::getTicket(), CalibAnaPlot::HaddAllDataFile(), joint_fit_2017_fc_submit(), dbutils::gui::DCSConfigEditorDisplay::loadHVAndTemps(), dbutils::gui::DAQConfigEditorDisplay::loadThresholdsAndMasks(), CalibAnaPlot::MakeDir(), MakeDir(), nova_official_data_release(), OnMonPlotMaker(), lem::LEMMixer::respondToOpenInputFile(), novadaq::BackgroundProcess::run(), ana::SAMDefinitionExists(), ana::SAMProjectSource::SAMProjectSource(), beamlinegeo::SystemID::SystemID(), and ana::ProfilerSupport::~ProfilerSupport().
system | ( | "hadd -O microbeam.root microbeam_*.root" | ) |
while | ( | 1 | ) |
Definition at line 55 of file plot.C.
References c1, fclose(), voxelSizeX, voxelSizeY, and voxelSizeZ.
c1 = new TCanvas ("c1","",20,20,1200,900) |
Float_t d |
Definition at line 236 of file plot.C.
Referenced by sim::ParticleNavigator::Add(), art::FileCatalogMetadata::addMetadata(), beamlinereco::ToFSingleCounterAnalysis::analyze(), align::Alignment::analyze(), beamlinereco::EventWaveformDump::analyze(), mono::SlowMonopoleAna::analyze(), beamlinereco::ToFAnalysisMini::analyze(), air::AirKalmanAna::analyze(), beamlinereco::ToFPositionRecoAnalysis::analyze(), comi::FEBFlash::analyze(), caf::ArrayVectorProxyBase::ArrayVectorProxyBase(), art::AssnsNode< L, R, D >::AssnsNode(), ana::AutoPlaceLegend(), beamlinereco::ToFPositionRecoAnalysis::beginJob(), ana::best_spline_fcn0(), ana::best_spline_fcn1(), ana::best_spline_mode_fcn(), genie::utils::nuclear::BindEnergy(), nova::dbi::RunHistory::BuildMC(), caf_nue_data_mc(), stan::variational::normal_meanfield::calc_grad(), stan::variational::normal_fullrank::calc_grad(), vdt::Segment::CalcChi2Line0(), caldp::TCTrack::CalcFiberVelocity(), beamlinereco::WCTrackAlg::calculateTheMomentum(), beamlinereco::TimeOfFlightReco::calculateTime(), beamlinereco::ToFSingleCounterAnalysis::calculateTime(), CheckForNumFinStateNucleonsInconsistentWithTarget(), geo::ClosestApproach(), genie::utils::kinematics::COHImportanceSamplingEnvelope(), g4n::G4Alg::CollectFLSHitsAndParticles(), genie::RSHelicityAmplModelCC::Compute(), keras::LayerMaxPooling::compute_output(), bpfit::dEdxCalculator::computeDEDX(), fuzz::FuzzyKMeanAlg::ComputeDij(), art::detail::TwoArgInsert< cet::map_vector< T > >::concatenate(), ContourComparisonPlot(), CLHEP::MixMaxRng::convert1double(), genie::geometry::PlaneParam::ConvertMaster2Top(), geo::GeometryBase::CountCellsOnLine(), CountMass(), ana::TargetCount::CountMass(), util::CountXY(), datamc_ND_numu_kinematics(), datamc_ND_numu_kinematics_FHC(), datamc_ND_numu_kinematics_FHC_pTBins(), datamc_ND_numu_kinematics_FHC_REW(), datamc_ND_numu_kinematics_FHC_REW_pTBins(), datamc_ND_numu_kinematics_REW(), datamc_ND_numu_kinematics_RHC(), datamc_ND_numu_kinematics_RHC_pTBins(), datamc_ND_numu_kinematics_RHC_REW(), datamc_ND_numu_kinematics_RHC_REW_pTBins(), nova::dbi::dBTable_(), nova::database::dBTable_(), genie::BYPDF::DeltaDU(), osc::EarthModel::DensityStacey(), bpfit::Path::Dir(), genie::utils::intranuke::Dist2Exit(), genie::utils::intranuke2018::Dist2Exit(), genie::utils::intranuke::Dist2ExitMFP(), genie::utils::intranuke2018::Dist2ExitMFP(), fuzz::FuzzyKMeanAlg::Distance(), CLHEP::RandFlat::distributionName(), novaddt::HoughTrackMaker::do_like_zukai(), genie::mueloss::gsl::BezrukovBugaevIntegrand::DoEval(), ana::CovMxSurface::DrawSurfacePoint(), DrawSurfacePoint(), geo::DsqrToLine(), stan::variational::normal_fullrank::entropy(), util::EventBox(), genie::BaryonResonanceDecayer::EvolveDeltaBR(), fake_future_data(), dq::FlasherFinder::FEBFlashHits(), comi::FEBFlash::FEBTimeSlice(), caldp::TCTrack::FiberVelocity(), beamlinereco::ToFFilter::filter(), beamlinereco::DigitizerSaturationFilter::filter(), dq::FlasherFinder::Filter(), beamlinereco::ToFClusterAlg::FindClusters(), dq::FlasherFinder::FindInstigators(), cmf::SpectrumPredictionMaker::FindOscillationPoints(), stan::math::finite_diff_grad_hessian(), stan::math::finite_diff_gradient(), stan::math::finite_diff_hessian(), trk::RLFit::Fit(), novaddt::TrackFit::FitView(), ana::Hist::FromDirectory(), stan::lang::generate_bare_type(), genie::Intranuke::GenerateStep(), genie::Intranuke2018::GenerateStep(), get_data_and_cosmic(), sn::SupernovaMCCluster::GetDaughters(), ana::GeniePCASyst::getHist(), jmshower::NueSelLID::GetPointDoca(), jmshower::RecoJMShower::GetPointDoca(), om::HistoSet::GetTH1F(), om::HistoSet::GetTH2F(), genie::geometry::ROOTGeomAnalyzer::GetWeight(), novaddt::UpMuTrigger::GetXYZ(), novaddt::UpMuAna::GetXYZ(), goodness_of_fit(), stan::model::grad_hess_log_prob(), stan::math::grad_hessian(), gsDefaultInterp(), airshower::AirSlicer::HoughRhoTheta(), genie::utils::kinematics::InelYLim_X(), genie::utils::kinematics::electromagnetic::InelYLim_X(), genie::geometry::FidSphere::Intercept(), genie::geometry::FidCylinder::InterceptUncapped(), stan::math::inv_Phi(), joint_fit_future_bestfit_univ(), joint_fit_future_contour_univ(), keras::KerasModel::KerasModel(), util::LinFit(), util::LinFitUnweighted(), dbutils::RunHistory::Load(), nerd::NERDEval::load_anchors(), keras::LayerConv2D::load_weights(), genie::LwlynSmithFF::LoadConfig(), nova::dbi::RunHistory::LoadDAQRunHistory(), lsqr_fprime(), LZ4_wildCopy(), make_decomp(), make_fc_nus_surfs_nersc_2019(), make_michel(), make_pi0_xcheck(), make_xsec_tuning_hists_mp5(), make_xsec_wgts_2018_hists(), MakeSurface(), MakeSurfaceLLTest(), MakeSurfaceNoNDOsc(), geo::GeometryBase::MaterialsBetweenPoints(), stan::math::matrix_exp_2x2(), mrbrem_get_initial_spectra(), mrbrem_get_reweighted_spectra(), mre_blessed(), mre_comp_split(), novaddt::NuMuTrigger::n3DCellsToEdge(), caf::ArrayVectorProxyBase::Name(), hough::IslandsTH2::Nislands(), genie::geometry::PlaneParam::Normalize(), nuebar_signif(), genie::SmithMonizUtils::Func1D< C >::operator()(), om::HistoTable::operator[](), trk::CosmicTrackUtilities::PathLengthInCell(), calib::PathLengthInCell(), genie::geometry::PlaneParam::PlaneParam(), plot_BEN(), TMVA::TMVAGlob::plot_logo(), plot_pi0_xcheck(), plot_prediction_systs(), PlotInfo::PlotInfo(), ana::PointDistanceToBox(), slid::ParticleIDAlg::PointDoca(), art::TimeTracker::postEventProcessing(), art::TimeTracker::postEventReading(), art::TimeTracker::preEventProcessing(), art::TimeTracker::preEventReading(), ddthelpers::print(), genie::geometry::PlaneParam::Print(), calib::ResizeDetector::produce(), MergeCollections::MergeCollections::produce(), MergeG4Collections::MergeG4Collections::produce(), numusand::FillSandbox::produce(), geo::LiveGeometry::ProjectedDistance(), geo::ProjectToBoxEdge(), evgb::CRYHelper::ProjectToBoxEdge(), evgen::CORSIKAGen::ProjectToBoxEdge(), keras::DataChunk2D::read_from_file(), om::OnMonProd::reconfigure(), art::MemoryTracker::recordEventData(), art::MemoryTracker::recordModuleData(), art::TimeTracker::recordTime(), HepGeom::Reflect3D::Reflect3D(), ana::LoadFromRegistry< BaseClass >::Register(), hough::MultiHough2P::ReweightHits(), hough::Hough2P::RhoTheta(), hough::MultiHough2P::RhoTheta(), trk::RLFit::RLFit(), rock(), ana::MCMCSamples::RunDiagnostics(), stan::variational::normal_meanfield::sample(), stan::variational::normal_fullrank::sample(), novaddt::calib::HitMap< T, Dimension >::Scale(), stan::io::dump_reader::scan_dim(), bpfit::Path::ScrubOne(), novaddt::TrackFit::SeedWeights(), trk::RLFit::SeedWeights(), keras::DataChunk2D::set_data(), keras::DataChunkFlat::set_data(), stan::mcmc::stepsize_adaptation::set_delta(), stan::mcmc::base_nuts_classic< Model, diag_e_metric, expl_leapfrog, BaseRNG >::set_max_delta(), stan::mcmc::base_nuts< Model, diag_e_metric, expl_leapfrog, BaseRNG >::set_max_delta(), stan::mcmc::base_xhmc< Model, diag_e_metric, expl_leapfrog, BaseRNG >::set_max_deltaH(), stan::mcmc::base_nuts_classic< Model, diag_e_metric, expl_leapfrog, BaseRNG >::set_max_depth(), stan::mcmc::base_nuts< Model, diag_e_metric, expl_leapfrog, BaseRNG >::set_max_depth(), stan::mcmc::base_xhmc< Model, diag_e_metric, expl_leapfrog, BaseRNG >::set_max_depth(), stan::mcmc::base_xhmc< Model, diag_e_metric, expl_leapfrog, BaseRNG >::set_x_delta(), genie::GHepParticle::SetFirstDaughter(), genie::GHepParticle::SetLastDaughter(), ana::covmx::Sample::SetPOT(), comi::FEBFlash::SliceStatistics(), solve(), osc::analytic::SolveCubic(), art::Source< T >::Source(), art::TimeTracker::startTime(), TEST(), TEST_F(), TestMatrix(), util::TimeSlice(), util::TimeSort(), geo::GeometryBase::TotalMass(), genie::Intranuke::TransportHadrons(), genie::Intranuke2018::TransportHadrons(), uncertainty1png(), uncertainty2png(), novaddt::TrackFit::UtilLinFit(), genie::geometry::PlaneParam::Vn(), genie::ReinSehgalRESPXSec::XSec(), genie::BSKLNBaseRESPXSec2014::XSec(), CLHEP::RandExpZiggurat::ziggurat_REXP(), and CLHEP::RandGaussZiggurat::ziggurat_RNOR().
Float_t den |
Definition at line 36 of file plot.C.
Referenced by ana::MultiverseCorrelation::calculate_correlation_matrix(), FOMCalc(), for(), INukeNucleonCorr::getCorrection(), om::HitCounts::GetRawEventSummary(), ana::SystMaker::MakeISyst(), plot_recoE_numu(), ana::RatioAsymmError(), ana::RatioAsymmErrorScaled(), ana::RatioAsymmErrorWithBkg(), ana::RatioAsymmErrorWithBkgScaled(), and wrong_sign_uncertainty().
TH1F* h1 = new TH1F("h1","Nucleus marker intensity",100,1,300) |
TH1F* h10 = new TH1F("h10bis","Dose distribution in Cytoplasm",100,0.001,.2) |
Definition at line 188 of file plot.C.
Referenced by Plotting_MakeBlessedSlices().
TH1F* h11 = new TH1F("h11 ","",100,1,300) |
Definition at line 43 of file plot.C.
Referenced by osc::OscCalcPMNSOptEigen::BuildHam(), osc::_PMNSOpt< T >::BuildHlv(), goodness(), and Plotting_MakeBlessedSlices().
TH1F* h1bis = new TH1F("h1bis","Dose distribution in Nucleus",100,0.001,1.) |
TH1F* h2 = new TH1F("h2","Cytoplasm marker intensity",100,1,300) |
Definition at line 45 of file plot.C.
Referenced by genie::AlgConfigPool::AddRootObjParameter(), upmuana::UpMuAnalysis::analyze(), supernova::sliceAna::CalcDTC(), om::HistoSet::CopyAndResetOne(), corrected_PE(), corrected_PE_mean(), ana::PredictionInterp::DebugPlotColz(), drawPlot(), DrawPlots(), FD_plots(), fit_thresh_corrs(), fit_thresh_corrs_fb(), for(), genie::LwlynSmithQELCCPXSec::FullDifferentialXSec(), GammaFit(), ana::covmx::CovarianceMatrix::GetCovMxRelative(), getSigmaPlots(), getSigmaPlotsAll(), GetSurf(), goodness(), om::IPC::HandleHistogramRequests(), lem::EventSummary::IsSig(), ana::Make2DFrom1D(), make_2hitq(), make_selectgoodclust(), make_selectgoodclust2(), make_spalld(), make_spallq(), make_spallt8mev(), MakeHist(), MakePlot(), trident::DimuonSliceAna::PlaneKS(), plot_3flavor_withsysts(), plot_angles(), plot_beam_angles(), plot_nhit(), plot_positions(), plot_residZ(), plot_times(), PlotComp(), PlotDB_Web(), PlotEfficiency(), Plotting_MakeBlessedSlices(), evdb::ColorScale::SetBounds(), tdslicer::TDSlicer::SortStuff(), test_nue2018_surface(), test_stanfit_withsysts(), and om::PlotViewer::UpdateCompare().
TH1F* h20 = new TH1F("h20 ","",100,1,300) |
Definition at line 46 of file plot.C.
Referenced by for(), and Plotting_MakeBlessedSlices().
TH1F* h2bis = new TH1F("h2bis","Beam stopping power at cell entrance",200,0,300) |
TH2F* histbis = new TH2F("histbis","histbis",50,-20,20,50,-20,20) |
TH2F* histter = new TH2F("histter","histter",50,-20,20,50,-20,20) |
Int_t ncols =0 |
Definition at line 53 of file plot.C.
Referenced by genie::utils::math::CholeskyCalculateCorrelatedParamVariations(), genie::utils::math::CholeskyDecomposition(), genie::utils::math::CholeskyGenerateCorrelatedParams(), genie::utils::math::CholeskyGenerateCorrelatedParamVariations(), cet::sqlite::detail::fillData(), cet::sqlite::detail::get_result(), and osc::OscCalcPMNSOptEigen::PrintMatrixAddresses().
Int_t nentries = (Int_t)ntuple2->GetEntries() |
TNtuple* ntupleYX = new TNtuple("CYTOPLASM","ntuple","Y:X:vox") |
TNtuple* ntupleYXN = new TNtuple("NUCLEUS","ntuple","Y:X:vox") |
TNtuple* ntupleZX = new TNtuple("CYTOPLASM","ntuple","Z:X:vox") |
Definition at line 25 of file plot.C.
Referenced by accum_nue_numu_equivalent(), accum_nue_numu_equivalent_fhc(), accum_nue_numu_equivalent_rhc(), cvn::PixelMap::Add(), ana::Hist::Add(), genie::PrimaryLeptonGenerator::AddToEventRecord(), genie::OutgoingDarkGenerator::AddToEventRecord(), genie::flux::GDk2NuFluxXMLHelper::AnglesToAxis(), genie::flux::GNuMIFluxXMLHelper::AnglesToAxis(), geo::AverageCellPathLength(), ana::CovMxExperiment::ChiSq(), ColdWarm(), ana::MichelDecomp::ComputeScaleFactor(), confusionMatrix(), confusionMatrixProng(), ana::TargetCount::CountMass(), DrawDataMC(), DrawMCOnly(), estimate_cosmics(), estimate_cosmics_triggeronly(), calib::EnergyLossVsDistance::Eval(), genie::flux::GFLUKAAtmoFlux::FillFluxHisto(), genie::flux::GBGLRSAtmoFlux::FillFluxHisto(), genie::Intranuke::GenerateStep(), genie::Intranuke2018::GenerateStep(), calib::Calibrator::GetAttenScale(), ana::GetBinScaleWS(), ana::Hist::GetEigenStan(), ana::MichelDecomp::GetNCScale(), ana::MichelDecomp::GetNueScale(), ana::MichelDecomp::GetNumuScale(), calib::Calibrator::GetPECorr(), photrans::ImprovedTransport::GetPosCorr(), ana::graphAsymmErrorWithBkgScaled(), heatMap(), lu_factorize(), cmf::PlotUtilities::MakeEnergySpectraFromBins(), MakeExtrapSurface(), genie::flux::GDk2NuFlux::MoveToZ0(), genie::flux::GSimpleNtpFlux::MoveToZ0(), genie::flux::GNuMIFlux::MoveToZ0(), neutKEsyst(), ana::GenieMultiverseNormalizedSpectra::NormalizeSpectra(), genie::flux::GDk2NuFluxXMLHelper::ParseParamSet(), genie::flux::GNuMIFluxXMLHelper::ParseParamSet(), genie::utils::intranuke::PhaseSpaceDecay(), genie::utils::intranuke2018::PhaseSpaceDecay(), ana::PlotAllCrossSectionResult(), PlotSyst(), PlotSysts(), ana::SingleSampleExperiment::PredHistIncCosmics(), ana::PredictionScaleComp::PredictSyst(), genie::NucBindEnergyAggregator::ProcessEventRecord(), ana::RatioAsymmErrorScaled(), ana::RatioAsymmErrorWithBkgScaled(), genie::PathLengthList::ScalePathLength(), TMVA::TMVAGlob::SetFrameStyle(), HepGeom::Transform3D::setIdentity(), osc::OscCalcSterileBeam::SetKaonScale(), osc::OscCalcSterileBeam::SetMuonScale(), osc::OscCalcSterileBeam::SetPionScale(), genie::supernova::OrderedSampler::SetProbScale(), genie::supernova::GSNovaModel::SetProbScale(), genie::geometry::GeomVolSelectorI::SetSI2Local(), ana::NeutronVisEScaleSyst2018::Shift(), ana::NumuGEANTScaleSyst::Shift(), ana::LEMScaleSyst::Shift(), ana::RemIDScaleSyst::Shift(), ana::NumuEnergyScaleSyst::Shift(), ana::NumuRelEnergyScaleSyst::Shift(), genie::DISHadronicSystemGenerator::SimulateFormationZone(), SpectrumParamEffectsAna(), genie::utils::intranuke::StepParticle(), genie::utils::intranuke2018::StepParticle(), sterile_demo(), calib::Calibrator::SystematicUncertaintyScale(), TheoryLine_E(), evdb::Colors::UnpackColorScale(), om::PlotViewer::UpdateCompare(), and genie::flux::GDk2NuFluxXMLHelper::~GDk2NuFluxXMLHelper().
Float_t tmp |
Definition at line 36 of file plot.C.
Referenced by ana::ReweightableSpectrum::_SaveTo(), ana::CovMxManager::AddSystematic(), AnaResultsLoad(), BlessedPlotsLoad(), ana::covmx::CovarianceMatrix::BuildFullCovMx(), genie::QPMDISStrucFuncBase::CalcPDFs(), genie::utils::math::CholeskyDecomposition(), art::PtrVectorBase::clear(), art::SummedValue< T >::clear(), art::Handle< T >::clear(), keras::LayerConv2D::compute_output(), CLHEP::MixMaxRng::convert1double(), CutTableLoad(), datamc(), DataVtxDistributionLoad(), fhicl::detail::decode_tuple(), DecorrelateFD(), DecorrelateND(), lem::MatchableEvent::Downsampled(), DrawBins(), DrawCCOscillations(), calib::AbsCalib::endRun(), stan::variational::normal_fullrank::entropy(), util::EnvExpansion(), osc::_PMNS< T >::EvalEqn10(), ExtendedAxesLoad(), FDDataMCSystBandLoad(), FitSystEffectsLoad(), GetAllSamples(), GetContour(), GetCosmics(), ana::ISurface::GetGraphs(), ana::GetLT(), GetNCSamples(), GetNumuSamples(), GetOutputFileName(), ana::GetPOT(), GetPOT(), GetSystConcat(), GetSystConcats(), ana::GetSystematics2018(), ana::CutOptimization::Integrate(), ana::covmx::CovarianceMatrix::LoadFrom(), LoadMaps(), ana::LoadMaps(), MakeNus17Prediction(), MakeNus17PredictionSysts(), MakeNusPrediction(), MakeNusPredictionSystsAna01(), ana::InteractionSpectra::MakePlot(), ana::ResolutionScan::MakePlot(), MakeSurfaceBinningStudy(), geo::GeometryBase::MakeTmpFile(), ana::FluxDecomp::MakeWeightsNumuFromPion(), ana::BENDecomp::MakeWeightsNumuFromPion(), MarshaledG4String::marshal1(), MarshaledExN04MuonHit::marshal1(), MarshaledExN04TrackerHit::marshal1(), MarshaledG4VHitsCollection::marshal1(), MarshaledG4HCofThisEvent::marshal1(), MarshaledG4HitsCollection::marshal1(), MarshaledExN04CalorimeterHit::marshal1(), MarshaledExN02TrackerHit::marshal1(), MarshaledG4THitsCollection< T >::marshal1(), MarshaledExN04MuonHit::marshal2(), MarshaledExN04TrackerHit::marshal2(), MarshaledG4VHitsCollection::marshal2(), MarshaledExN02TrackerHit::marshal2(), MarshaledExN04CalorimeterHit::marshal2(), MarshaledExN04CalorimeterHit::marshal3(), MarshaledG4VHitsCollection::marshal3(), MarshaledExN02TrackerHit::marshal3(), MarshaledExN02TrackerHit::marshal4(), MarshaledExN04CalorimeterHit::marshal4(), Eigen::matrix_exp_pade13(), Eigen::matrix_exp_pade3(), Eigen::matrix_exp_pade5(), Eigen::matrix_exp_pade7(), Eigen::matrix_exp_pade9(), median_contours(), keras::missing_activation_impl(), mre_blessed(), NDDataMCSystBandLoad(), nova_t2k_comparison(), fhicl::OptionalTupleAs< T(ARGS...)>::operator()(), art::const_AssnsIter< L, R, D, Dir >::operator+(), art::const_AssnsIter< L, R, D, Dir >::operator++(), art::const_AssnsIter< L, R, D, Dir >::operator-(), art::const_AssnsIter< L, R, D, Dir >::operator--(), cet::value_ptr< TFile >::operator=(), art::const_AssnsIter< L, R, D, Dir >::operator[](), partial_pivot(), plot_hists(), ana::CutOptimization::PlotDebug(), ana::PlotDebug(), pots(), Print(), PrintMeanRMSScanPlot(), PrintPlot(), PrintResolutionPlot(), upmuana::UpMuProb::produce(), genie::SmithMonizUtils::Q2QES_SM_lim(), genie::SmithMonizUtils::QEL_EnuMin_SM(), bsim::readWeightLocations(), genie::MECGenerator::RecoilNucleonCluster(), jmshower::RecoJMShower::RecoShowers(), ana::ResetSterileCalcToDefault(), SaveMaps(), ana::FluxReweight::SavePlots(), ana::MichelDecomp::SavePlots(), ana::NoReweight::SavePlots(), ana::TruthReweight::SavePlots(), ana::RecoReweight::SavePlots(), ana::ModularExtrap::SavePlotsNue(), ana::ModularExtrap::SavePlotsNueRHC(), ana::ModularExtrap::SavePlotsNumu(), ana::PredictionXSecTuning::SaveTo(), ana::ReactorExperiment::SaveTo(), ana::CountingExperiment::SaveTo(), ana::SolarConstraints::SaveTo(), ana::NuISyst::SaveTo(), ana::TrivialBkgdEstimator::SaveTo(), ana::PredictionNoOsc::SaveTo(), ana::PredictionSterile::SaveTo(), ana::TrivialSignalEstimator::SaveTo(), ana::FDPredictionSterile::SaveTo(), ana::ModularExtrap::SaveTo(), ana::FluxReweight::SaveTo(), jw::TrivialPrediction::SaveTo(), ana::CheatDecomp::SaveTo(), ana::NDPredictionSterile::SaveTo(), ana::PredictionExtrap::SaveTo(), ana::Binning::SaveTo(), ana::FitInAnaBinsBkgdEstimator::SaveTo(), ana::NumuCC2p2hBkgdEstimator::SaveTo(), ana::nueccinc::NueCCIncMRECorrection::SaveTo(), ana::NCDecomp::SaveTo(), ana::NDExtrapBeamComponent::SaveTo(), ana::MultiExperiment::SaveTo(), ana::NueDecomp::SaveTo(), ana::PredictionCombinePeriods::SaveTo(), ana::SingleSampleExperiment::SaveTo(), ana::NDExtrapComponent::SaveTo(), ana::FluxMultiverseSyst::SaveTo(), ana::NumuDecomp::SaveTo(), ana::PredictionAddRock::SaveTo(), ana::CrossSectionSpectra::SaveTo(), ana::NDPredictionNoOsc::SaveTo(), ana::PredictionSystJoint2018::SaveTo(), ana::PredictionExtendToPeripheral::SaveTo(), ana::PredictionSystJointDemo::SaveTo(), ana::NDExtrap::SaveTo(), ana::TrivialPrediction::SaveTo(), ana::PredictionNoExtrap::SaveTo(), ana::FDExtrap::SaveTo(), ana::PredictionScaleComp::SaveTo(), ana::ProportionalDecomp::SaveTo(), ana::CutOptimization::SaveTo(), ana::TrivialCrossSectionAnalysis::SaveTo(), ana::FakeDecomp::SaveTo(), ana::TrivialExtrap::SaveTo(), ana::CrossSectionAnalysis::SaveTo(), ana::PredictionInterp::SaveTo(), ana::Multiverse::SaveTo(), ana::TwoSampleDecomp::SaveTo(), ana::FrequentistSurface::SaveTo(), ana::SystShifts::SaveTo(), ana::SystMakerShiftSigma::SaveTo(), ana::SpectrumComponents::SaveTo(), ana::covmx::CovarianceMatrix::SaveTo(), ana::FluxDecomp::SaveTo(), ana::nueccinc::NueCCIncCrossSectionAnalysis::SaveTo(), ana::ModularExtrapSterile::SaveTo(), ana::SaveTo(), ana::MichelDecomp::SaveTo(), ana::BENDecomp::SaveTo(), ana::NoReweight::SaveTo(), ana::GenieMultiverseSpectra::SaveTo(), ana::SystMakerShift::SaveTo(), ana::PredictionSystNue2017::SaveTo(), ana::PredictionSystNumu2017::SaveTo(), ana::GenericSystematicDef< SRType >::SaveTo(), ana::TruthReweight::SaveTo(), ana::DataMCPair::SaveTo(), ana::nueccinc::NueCCIncCrossSectionTemplates::SaveTo(), ana::RecoReweight::SaveTo(), ana::SystMaker::SaveTo(), ana::nueccinc::NueCCIncEnhancedSamples::SaveTo(), ana::Spectrum::SaveTo(), ana::SystematicsMaker::SaveTo(), ana::ISurface::SaveToHelper(), ana::SaveToUpDownSpectra(), SideBandLoad(), LSTME::Png3dVars::sortDict(), stan::test::unit::stod(), stan::json::json_data_handler::string(), genie::GHepRecord::SwapParticles(), TEST(), locator::RndmLocatorTable::TNS(), ana::CutOptimization::ToHist(), ana::TrivialPrediction::TrivialPrediction(), uptime(), stan::math::wiener_lpdf(), ana::WriteCAFMetadata(), genie::SlowRsclCharmDISPXSecLO::XSec(), genie::AivazisCharmPXSecLO::XSec(), art::PtrVector< T >::zeroTransients(), and ana::ProfilerSupport::~ProfilerSupport().
Float_t X |
Definition at line 38 of file plot.C.
Referenced by remid::ReMIdDedx::analyze(), bpfit::BreakPointAna::analyze(), fuzz::FuzzyKValidate::analyze(), remid::ReMIdDedxStudies::analyze(), ana::AutoPlaceLegend(), ifdb::IFDBSpillInfo::BpmAtTarget(), beamlinereco::WCTrackAlg::buildFourPointTracks(), stan::math::chol2inv(), geo::ClampRayToDetectorVolume(), genie::mueloss::BetheBlochModel::dE_dx(), bpfit::Path::Dir(), ana::FCSurface::DrawBins(), chaninfo::CosmicEff::endJob(), simb::MCParticle::EndPx(), simb::MCParticle::EndX(), bsf::BremShowerFilter::filter(), novaddt::MichelETrigger::filter(), beamlinereco::WCTrackAlg::findTheHitPositions(), trk::KalmanTrack::FindTracks(), novaddt::GetExpectations(), calib::GetExpectations(), ifdb::IFDBSpillInfo::GetGaussFit(), om::MicroErrors::GetMicroSliceSummary(), om::NanoErrors::GetNanoSliceSummary(), ifdb::IFDBSpillInfo::GetStats(), trk::KalmanTrackMerge::JoinTracks(), make_cosmic_eff_table(), make_plots(), makeTraj(), trk::CosmicTrackUtilities::MakeZBoundaryMap(), calib::MakeZBoundaryMap(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), trk::KalmanTrackMerge::MatchTracks(), art::PtrRemapper::operator()(), beamlinereco::WCTrackReco::produce(), zcl::FMMTracker::produce(), cheat::MCCheater::produce(), evgen::CosmicsGen::ProjectMuonsToDetectorBigBox(), osc::_PMNS< T >::PropMatter(), ana::UnfoldTikhonov::RecoTruthPrediction(), TEST(), zcl::FmmTrackerValidation::vfit(), zcl::FmmTrackerAna::vfit(), and trk::KalmanTrackMerge::ViewMergeTracks().
Double_t X1 |
Definition at line 264 of file plot.C.
Referenced by genie::mueloss::BetheBlochModel::dE_dx(), jmshower::RecoJMShower::GetInterCellTransDedxProb(), jmshower::RecoJMShower::GetInterPlaneDedxProb(), geo::GeometryBase::getPlaneAndCellID(), and slicer_production_validation().
Double_t X2 |
Definition at line 264 of file plot.C.
Referenced by ana::KrigeKernel::AddPoint(), and geo::GeometryBase::getPlaneAndCellID().
Xc = -1295.59e3 - 955e3*sin(10*TMath::Pi()/180) |
double Y |
Definition at line 38 of file plot.C.
Referenced by remid::ReMIdDedx::analyze(), bpfit::BreakPointAna::analyze(), fuzz::FuzzyKValidate::analyze(), remid::ReMIdDedxStudies::analyze(), air::AirKalmanAna::analyze(), air::AirKalmanAna::AngleBetweentrk(), ana::AutoPlaceLegend(), ifdb::IFDBSpillInfo::BpmAtTarget(), beamlinereco::WCTrackAlg::buildFourPointTracks(), geo::ClampRayToDetectorVolume(), CLHEP::MixMaxRng::convert1double(), bpfit::Path::Dir(), ana::FCSurface::DrawBins(), chaninfo::CosmicEff::endJob(), simb::MCParticle::EndPy(), simb::MCParticle::EndY(), bsf::BremShowerFilter::filter(), novaddt::MichelETrigger::filter(), beamlinereco::WCTrackAlg::findTheHitPositions(), trk::KalmanTrack::FindTracks(), om::MicroErrors::GetMicroSliceSummary(), om::NanoErrors::GetNanoSliceSummary(), trk::KalmanTrackMerge::JoinTracks(), make_cosmic_eff_table(), make_plots(), makeTraj(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), trk::KalmanTrackMerge::MatchTracks(), beamlinereco::WCTrackReco::produce(), zcl::FMMTracker::produce(), cheat::MCCheater::produce(), beamlinereco::WCTrackAlg::projectToMagnetFace(), ana::UnfoldTikhonov::RecoTruthPrediction(), zcl::FmmTrackerValidation::vfit(), zcl::FmmTrackerAna::vfit(), trk::KalmanTrackMerge::ViewMergeTracks(), and stan::math::von_mises_rng().
Double_t Y1 |
Definition at line 264 of file plot.C.
Referenced by for(), jmshower::RecoJMShower::GetInterCellTransDedxProb(), jmshower::RecoJMShower::GetInterPlaneDedxProb(), geo::GeometryBase::getPlaneAndCellID(), and slicer_production_validation().
Double_t Y2 |
Definition at line 264 of file plot.C.
Referenced by ana::KrigeKernel::AddPoint(), geo::GeometryBase::getPlaneAndCellID(), and slicer_production_validation().
Float_t Z |
Definition at line 38 of file plot.C.
Referenced by genie::NucleonDecayPrimaryVtxGenerator::AddInitialState(), genie::NNBarOscPrimaryVtxGenerator::AddInitialState(), genie::InitialStateAppender::AddNucleus(), genie::NuETargetRemnantGenerator::AddTargetNucleusRemnant(), genie::HadronicSystemGenerator::AddTargetNucleusRemnant(), genie::FermiMover::AddTargetNucleusRemnant(), genie::QELEventGenerator::AddTargetNucleusRemnant(), genie::QELEventGeneratorSM::AddTargetNucleusRemnant(), genie::AMNuGammaGenerator::AddTargetRemnant(), genie::MECGenerator::AddTargetRemnant(), genie::PrimaryLeptonGenerator::AddToEventRecord(), genie::OutgoingDarkGenerator::AddToEventRecord(), vf::TrackEva::analyze(), remid::ReMIdDedx::analyze(), bpfit::BreakPointAna::analyze(), remid::ReMIdDedxStudies::analyze(), fuzz::FuzzyKValidate::analyze(), air::AirKalmanAna::analyze(), air::AirKalmanAna::AngleBetweentrk(), genie::utils::nuclear::BindEnergy(), beamlinereco::WCTrackAlg::buildFourPointTracks(), CheckForNumFinStateNucleonsInconsistentWithTarget(), CheckVertexDistribution(), geo::ClampRayToDetectorVolume(), genie::NievesQELCCPXSec::CNCTCLimUcalc(), ConvertToGHad(), ConvertToGTracker(), ana::TargetCount::CountMass(), ana::CrossSectionAnalysis::CrossSectionAnalysis(), genie::mueloss::BetheBlochModel::dE_dx(), genie::mueloss::BezrukovBugaevModel::dE_dx(), genie::mueloss::KokoulinPetrukhinModel::dE_dx(), genie::mueloss::PetrukhinShestakovModel::dE_dx(), bpfit::Path::Dir(), genie::alvarezruso::AREikonalSolution::Element(), genie::NaturalIsotopes::ElementData(), simb::MCParticle::EndPz(), simb::MCParticle::EndZ(), bsf::BremShowerFilter::filter(), novaddt::MichelETrigger::filter(), genie::FermiMomentumTable::FindClosestKF(), rb::Track::FindNeighbouringPointIndices(), trk::KalmanTrack::FindTracks(), genie::LocalFGM::GenerateNucleon(), genie::FGMBodekRitchie::GenerateNucleon(), genie::SpectralFunc1d::GenerateNucleon(), novaddt::GetExpectations(), calib::GetExpectations(), INukeNucleonCorr::getInstance(), photrans::ImprovedTransport::GetPosCorr(), genie::geometry::ROOTGeomAnalyzer::GetTargetPdgCode(), genie::EmpiricalMECPXSec2015::Integral(), genie::pdg::IonPdgCodeToZ(), trk::KalmanTrackMerge::JoinTracks(), genie::FermiMover::KickHitNucleon(), genie::mueloss::gsl::KokoulinPetrukhinIntegrand::KokoulinPetrukhinIntegrand(), zcl::SMMCluster::LinFit(), genie::NievesQELCCPXSec::LmunuAnumu(), genie::utils::config::LoadAllIsotopesForKey(), genie::IBDXSecMap::LoadConfig(), genie::FGMBodekRitchie::LoadConfig(), genie::SpectralFunc1d::LoadConfig(), genie::NuclearModelMap::LoadConfig(), genie::LocalFGM::LoadConfig(), genie::EffectiveSF::LoadConfig(), genie::SmithMonizUtils::LoadConfig(), genie::NaturalIsotopes::LoadTable(), main(), trk::WindowTrackingAlg::MakeTrack(), makeTraj(), trk::CosmicTrackUtilities::MakeZBoundaryMap(), calib::MakeZBoundaryMap(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), trk::KalmanTrackMerge::MatchTracks(), slicer::PointManager::NeighborScore(), novaddt::DBSlicer::NeighborScore(), genie::NaturalIsotopes::NElements(), genie::utils::gsl::wrap::NievesQELvcrIntegrand::NievesQELvcrIntegrand(), ana::TargetCount::NNucleons(), nuint09_qel1(), nuint09_qel2(), nuint09_qel3(), nuint09_qel4(), nuint09_qel5(), genie::mueloss::gsl::PetrukhinShestakovIntegrand::PetrukhinShestakovIntegrand(), plot_kinematics_cafana(), genie::SpectralFunc1d::Prob(), genie::FGMBodekRitchie::ProbDistro(), genie::QELEventGenerator::ProcessEventRecord(), jmshower::JMTrackMerge::produce(), beamlinereco::WCTrackReco::produce(), dif::DiFShowerFinder::produce(), cheat::MCCheater::produce(), beamlinereco::WCTrackAlg::projectToMagnetFace(), SelectInitState(), genie::NuclearModelMap::SelectModel(), genie::SmithMonizUtils::SetInteraction(), bpfit::Lutz::SetScatteringPlane(), dt::Chain::ToTrack(), genie::NievesQELCCPXSec::vcr(), zcl::FmmTrackerValidation::vfit(), zcl::FmmTrackerAna::vfit(), trk::KalmanTrackMerge::ViewMergeTracks(), stan::math::von_mises_rng(), genie::COHElasticPXSec::XSec(), genie::AlvarezRusoCOHPiPXSec::XSec(), genie::KovalenkoQELCharmPXSec::XSec(), genie::ReinSehgalRESPXSec::XSec(), and genie::BSKLNBaseRESPXSec2014::XSec().
Double_t Z1 |
Definition at line 264 of file plot.C.
Referenced by geo::LiveGeometry::DistToBack(), geo::LiveGeometry::DistToBottom(), geo::LiveGeometry::DistToClosestBadRegion(), geo::LiveGeometry::DistToEdgeXMinus(), geo::LiveGeometry::DistToEdgeXPlus(), geo::LiveGeometry::DistToTop(), geo::GeometryBase::getPlaneAndCellID(), geo::LiveGeometry::IsPointLiveInfo(), and geo::LiveGeometry::ProjectedDistance().
Double_t Z2 |
Definition at line 264 of file plot.C.
Referenced by genie::mueloss::gsl::PetrukhinShestakovIntegrand::DoEval(), geo::GeometryBase::getPlaneAndCellID(), and geo::LiveGeometry::ProjectedDistance().
Zc = -1327e3 + 955e3*cos(10*TMath::Pi()/180) |
Definition at line 264 of file plot.C.
Referenced by genie::FermiMomentumTable::FindClosestKF(), and for().
Double_t zz |
Definition at line 277 of file plot.C.
Referenced by align::Alignment::analyze(), numusand::NumuSandFxs::getAveTrackdEdxLast4Cells(), numusand::NumuSandFxs::getAveTrackdEdxLast6Cells(), numusand::NumuSandFxs::getAveTrackdEdxLast8Cells(), om::WatchListBox::LayoutCurrentListFrame(), om::WatchListBox::LayoutHardwareFrame(), and trk::KalmanTrack::SingleSegment().