Analysis Software
Documentation for sPHENIX simulation software
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
ctrl.cpp File Reference
#include "ctrl.h"
#include "inc.h"
#include <ctime>
#include <cmath>
#include <iomanip>
#include "hdo.h"
#include "ickw.h"
#include "conv.h"
#include "eo3.h"
#include "eo1.h"
#include "trancoeff.h"
#include <unistd.h>
#include <execinfo.h>
#include <signal.h>
+ Include dependency graph for ctrl.cpp:

Go to the source code of this file.

Functions

void handler (int sig)
 
void redirecterrorshlle_ (char *filename)
 
void initeoshlle_ (char *filename, int *ncols)
 
void initeoshlle3f_ (char *filename, double *B, double *volex0, double *delta0, double *aaa, double *bbb)
 
void initeoshlle1f_ (char *filename)
 
void inittrcoeff_ (double *etaS, double *zetaS)
 
void eoshlle_ (double *e, double *nb, double *nq, double *ns, double *T, double *mub, double *muq, double *mus, double *p)
 
void eosrangeshlle_ (double *emax, double *e0, double *nmax, double *n0, int *ne, int *nn)
 
void initfluidhlle_ (int *nx, int *ny, int *nz, double *minx, double *maxx, double *miny, double *maxy, double *minz, double *maxz)
 
void initichlle_ (char *filename, double *tau0)
 
void icgethlle3f_ (double *x, double *y, double *eta, double *e, double *nB, double *nQ, double *nS, double *vx, double *vy, double *vz)
 
void icgethlle_ (double *x, double *y, double *eta, double *e, double *nB, double *nQ, double *nS, double *vx, double *vy, double *vz)
 
void icsethlle_ (int *ix, int *iy, int *iz, double *tau0, double *e, double *nb, double *nq, double *ns, double *vx, double *vy, double *vz)
 
void inithydrohlle_ (double *_tau0, double *_tau_max, double *_dtau)
 
void dtauhlle_ (double *dtau)
 
void initoutputhlle_ (char *dir)
 
int getmaxstephlle_ (void)
 
void makestephlle_ (int *i)
 
void getvalueshlle_ (int *ix, int *iy, int *iz, double *e, double *p, double *nb, double *nq, double *ns, double *vx, double *vy, double *vz, double *viscCorrCutFlag)
 
void getvflaghlle_ (int *ix, int *iy, int *iz, double *viscCorrCutFlag)
 
void getvischlle_ (int *ix, int *iy, int *iz, double *pi, double *Pi)
 
double getxhlle_ (int *ix)
 
double getyhlle_ (int *iy)
 
double getzhlle_ (int *iz)
 
void destroyhlle_ (void)
 
void destroyeoshlle_ (void)
 
double gettimehlle_ (void)
 
double getenergyhlle_ (void)
 

Variables

ofstream ofile
 
EoSeos
 
TransportCoefftrcoeff
 
Fluidf
 
IC_KW * ic_kw
 
Hydroh
 
time_t start
 
time_t end
 
double tau0
 
double tau_max
 
double dtau
 
int maxstep
 

Function Documentation

void destroyeoshlle_ ( void  )

Definition at line 242 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 242 of file ctrl.cpp

References eos.

void destroyhlle_ ( void  )

Definition at line 230 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 230 of file ctrl.cpp

References end, f, h, ofile, start, and Acts::Test::time.

void dtauhlle_ ( double dtau)

Definition at line 156 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 156 of file ctrl.cpp

References Hydro::setDtau().

+ Here is the call graph for this function:

void eoshlle_ ( double e,
double nb,
double nq,
double ns,
double T,
double mub,
double muq,
double mus,
double p 
)

Definition at line 75 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 75 of file ctrl.cpp

References EoS::eos().

+ Here is the call graph for this function:

void eosrangeshlle_ ( double emax,
double e0,
double nmax,
double n0,
int *  ne,
int *  nn 
)

Definition at line 81 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 81 of file ctrl.cpp

double getenergyhlle_ ( void  )

Definition at line 255 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 255 of file ctrl.cpp

References Acts::UnitConstants::e, eta, Fluid::getCell(), Fluid::getNX(), Fluid::getNY(), Fluid::getNZ(), Cell::getPrimVar(), Hydro::getTau(), Fluid::getZ(), Acts::UnitConstants::ns, merge_hashes::p, tau, vx, vy, and vz.

+ Here is the call graph for this function:

int getmaxstephlle_ ( void  )

Definition at line 170 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 170 of file ctrl.cpp

References maxstep.

double gettimehlle_ ( void  )

Definition at line 248 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 248 of file ctrl.cpp

References end, start, and Acts::Test::time.

void getvalueshlle_ ( int *  ix,
int *  iy,
int *  iz,
double e,
double p,
double nb,
double nq,
double ns,
double vx,
double vy,
double vz,
double viscCorrCutFlag 
)

Definition at line 184 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 184 of file ctrl.cpp

References Acts::PhysicalConstants::c, Acts::UnitConstants::e, Fluid::getCell(), Cell::getPrimVar(), Hydro::getTau(), Cell::getViscCorrCutFlag(), Acts::UnitConstants::ns, merge_hashes::p, vx, vy, and vz.

+ Here is the call graph for this function:

void getvflaghlle_ ( int *  ix,
int *  iy,
int *  iz,
double viscCorrCutFlag 
)

Definition at line 192 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 192 of file ctrl.cpp

References Fluid::getCell(), and Cell::getViscCorrCutFlag().

+ Here is the call graph for this function:

void getvischlle_ ( int *  ix,
int *  iy,
int *  iz,
double pi,
double Pi 
)

Definition at line 198 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 198 of file ctrl.cpp

References Acts::PhysicalConstants::c, Fluid::getCell(), Cell::getpi(), Cell::getPi(), i, and j.

+ Here is the call graph for this function:

double getxhlle_ ( int *  ix)

Definition at line 212 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 212 of file ctrl.cpp

References Fluid::getX().

+ Here is the call graph for this function:

double getyhlle_ ( int *  iy)

Definition at line 218 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 218 of file ctrl.cpp

References Fluid::getY().

+ Here is the call graph for this function:

double getzhlle_ ( int *  iz)

Definition at line 224 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 224 of file ctrl.cpp

References Fluid::getZ().

+ Here is the call graph for this function:

void handler ( int  sig)

Definition at line 32 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 32 of file ctrl.cpp

References TauVsDIS_MachineLearning_Differentiation::array, and size.

void icgethlle3f_ ( double x,
double y,
double eta,
double e,
double nB,
double nQ,
double nS,
double vx,
double vy,
double vz 
)

Definition at line 101 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 101 of file ctrl.cpp

References ic_kw, and Acts::UnitConstants::ns.

void icgethlle_ ( double x,
double y,
double eta,
double e,
double nB,
double nQ,
double nS,
double vx,
double vy,
double vz 
)

Definition at line 112 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 112 of file ctrl.cpp

References ic_kw, and Acts::UnitConstants::ns.

void icsethlle_ ( int *  ix,
int *  iy,
int *  iz,
double tau0,
double e,
double nb,
double nq,
double ns,
double vx,
double vy,
double vz 
)

Definition at line 120 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 120 of file ctrl.cpp

References Acts::PhysicalConstants::c, Fluid::getCell(), Cell::saveQprev(), Cell::setAllM(), and Cell::setPrimVar().

+ Here is the call graph for this function:

void initeoshlle1f_ ( char *  filename)

Definition at line 64 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 64 of file ctrl.cpp

void initeoshlle3f_ ( char *  filename,
double B,
double volex0,
double delta0,
double aaa,
double bbb 
)

Definition at line 59 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 59 of file ctrl.cpp

void initeoshlle_ ( char *  filename,
int *  ncols 
)

Definition at line 53 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 53 of file ctrl.cpp

void initfluidhlle_ ( int *  nx,
int *  ny,
int *  nz,
double minx,
double maxx,
double miny,
double maxy,
double minz,
double maxz 
)

Definition at line 87 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 87 of file ctrl.cpp

void inithydrohlle_ ( double _tau0,
double _tau_max,
double _dtau 
)

Definition at line 142 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 142 of file ctrl.cpp

References dtau, maxstep, Hydro::setNSvalues(), start, tau0, tau_max, and Acts::Test::time.

+ Here is the call graph for this function:

void initichlle_ ( char *  filename,
double tau0 
)

Definition at line 94 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 94 of file ctrl.cpp

References ic_kw.

void initoutputhlle_ ( char *  dir)

Definition at line 162 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 162 of file ctrl.cpp

References Hydro::getTau(), Fluid::initOutput(), maxstep, and tau0.

+ Here is the call graph for this function:

void inittrcoeff_ ( double etaS,
double zetaS 
)

Definition at line 70 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 70 of file ctrl.cpp

void makestephlle_ ( int *  i)

Definition at line 176 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 176 of file ctrl.cpp

References Hydro::getTau(), and Hydro::performStep().

+ Here is the call graph for this function:

void redirecterrorshlle_ ( char *  filename)

Definition at line 45 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 45 of file ctrl.cpp

References handler(), ofile, and signal().

+ Here is the call graph for this function:

Variable Documentation

double dtau

Definition at line 28 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 28 of file ctrl.cpp

Referenced by LBT::DoEnergyLoss(), CLVisc::EvolveHydro(), LBT::Init(), inithydrohlle_(), main(), printParameters(), readParameters(), LBT::setParameter(), TEST(), and Hydroinfo_MUSIC::update_grid_info().

time_t end

Definition at line 26 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 26 of file ctrl.cpp

Referenced by planarity::add_to_embedding(), PHG4GDMLWrite::AddModule(), SColdQcdCorrelatorAnalysis::SCorrelatorJetTree::AddTracks(), Acts::AdaptiveMultiVertexFitter< input_track_t, linearizer_t >::addVtxToFit(), PHG4TpcDirectLaser::AppendLaserTrack(), KFParticle_Tools::appendTracksToIntermediates(), testing::internal::ArrayAwareFind(), symlist< T >::attach_sublist(), pq_tree::blocked_in_subtree(), BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_AUTO_TEST_CASE(), ActsFatras::BOOST_DATA_TEST_CASE(), pq_tree::bubble_up(), KFParticle_eventReconstruction::buildChain(), gbl::GblTrajectory::calcJacobians(), OnlBbcEvent::calculate(), MbdEvent::Calculate(), planarity::case_A(), planarity::case_B(), planarity::case_D(), planarity::case_E(), PHTFileServer::cd(), planar_embedding::check(), DecayFinder::checkIfCorrectHepMCParticle(), Acts::AdaptiveMultiVertexFitter< input_track_t, linearizer_t >::collectTrackToVertexCompatibilities(), Acts::MultiEigenStepperLoop< extensionlist_t, component_reducer_t, auctioneer_t >::componentIterable(), Acts::BoundaryCheck::computeClosestPointOnPolygon(), Acts::Experimental::detail::CylindricalDetectorHelper::connectInR(), Acts::Experimental::detail::CylindricalDetectorHelper::connectInZ(), Acts::MultiEigenStepperLoop< extensionlist_t, component_reducer_t, auctioneer_t >::constComponentIterable(), Fun4AllOscarInputManager::ConvertFromOscar(), planarity::correct_embedding(), Acts::createProtoMaterial(), planar_embedding::cyclic_next(), planar_embedding::cyclic_prev(), Acts::decodeBinning(), graph::del_all_edges(), graph::del_list(), graph::del_node(), destroyhlle_(), symlist< T >::detach_sublist(), AZigzag::DetermineCommonMode(), ActsExamples::Sequencer::determineEventsRange(), SColdQcdCorrelatorAnalysis::SCorrelatorJetTree::DetermineEvtsToGrab(), pq_tree::dfs(), planarity::dfs_bushform(), SColdQcdCorrelatorAnalysis::SCheckTrackPairs::DoDoubleTrackLoop(), Draw_ratio(), MyMonDraw::DrawHistory(), DaqMonDraw::DrawHistory(), MvtxMonDraw::DrawHistory(), CemcMonDraw::DrawSecond(), Acts::GeometryView3D::drawSegmentBase(), OnCalServer::dumpHistos(), Acts::ExaTrkXTimer::elapsed(), Acts::enumerate(), symlist< T >::erase(), ActsExamples::TruthVertexFinder::execute(), ActsExamples::MeasurementMapSelector::execute(), Acts::Extent::extend(), planarity::extend_embedding(), Fe55_main(), Acts::GeometryHierarchyMap< value_t >::fill(), FillHoughHist(), Acts::GeometryHierarchyMap< value_t >::find(), PHCASeeding::FindBiLinks(), TrkrClusterContainerv2::findCluster(), HFTrackEfficiency::findTracks(), KFParticle_Tools::findUniqueDaughterCombinations(), Acts::Experimental::Gx2Fitter< propagator_t, traj_t >::fit(), Acts::KalmanFitter< propagator_t, traj_t >::fit(), Acts::GaussianSumFitter< propagator_t, bethe_heitler_approx_t, traj_t >::fit_impl(), PHTFileServer::flush(), PHCASeeding::FollowBiLinks(), ActsExamples::Sequencer::fpeMaskCount(), Jetscape::Afterburner::GatherAfterburnerHadrons(), Acts::SurfaceArrayCreator::ProtoAxis::getBin(), Acts::detail::Axis< AxisType::Variable, bdt >::getBin(), KFParticle_truthAndDetTools::getHepMCInfo(), TrkrClusterContainerv3::getHitSetKeys(), TrkrClusterContainerv4::getHitSetKeys(), Acts::FsmwMode1dFinder::getMode(), HFTrackEfficiency::getNDaughters(), SColdQcdCorrelatorAnalysis::SCorrelatorJetTree::GetNumTrks(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::GetSumTrkMomentum(), gettimehlle_(), PhDi::GetValue(), GlobalVertexv1::GlobalVertexv1(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::GrabSubevents(), graph::hide_node(), Acts::AdaptiveGridTrackDensity< spatialTrkGridSize, temporalTrkGridSize >::highestDensityEntry(), graph::induced_subgraph(), HybridHadronization::Init(), fm_partition::init_filling_buckets(), Initialise_info(), graph::insert_reverse_edges(), pq_tree::integrity_check(), graph::is_bidirected(), Acts::detail::VerticesHelper::isInsidePolygon(), Jetv1::Jetv1(), json_emit_quoted_str(), json_emit_va(), graph::load(), luupda(), main(), ActsExamples::makeGroupBy(), ActsExamples::makeRange(), planarity::mark_all_neighbors_of_leaves(), testing::internal::BeginEndDistanceIsMatcher< DistanceMatcher >::Impl< Container >::MatchAndExplain(), MbdDigitization::MbdDigitization(), mg_dns_copy_questions(), mg_dns_uncompress_name(), mg_http_parse_header(), mg_parse_dns(), mg_parse_http(), mg_parse_uri(), PHG4GDMLWrite::Modularize(), PgPostCalBankIterator::next(), PHTFileServer::open(), ActsFatras::ContinuousProcess< physics_t, input_particle_selector_t, output_particle_selector_t, child_particle_selector_t >::operator()(), operator<<(), planar_embedding::operator=(), symlist< T >::operator=(), p_node::p_node(), ActsExamples::Options::parse(), parse_uri_component(), DecayFinder::parseDecayDescriptor(), KFParticle_sPHENIX::parseDecayDescriptor(), testing::internal::ParseInt32(), q_node::pertinent(), PHG4Showerv1::PHG4Showerv1(), planar_embedding::planar_embedding(), pq_tree::pq_tree(), PktSizeMon::Print(), PHG4HitReadBack::process_event(), MicromegasCombinedDataDecoder::process_event(), QAG4Decayer::process_event(), MBDStudy::process_event(), jetHistogrammer::process_event(), QAG4SimulationTruthDecay::process_event(), truthDecayTester::process_event(), BBCStudy::process_event(), MicromegasCombinedDataEvaluation::process_event(), FullJetFinder::process_event(), Acts::CombinatorialKalmanFilter< propagator_t, traj_t >::Actor< source_link_accessor_t, parameters_t >::processSelectedTrackStates(), planar_embedding::push_back(), pydump(), pylhef(), pyslha(), pyupda(), ActsExamples::IndexSourceLinkAccessor::range(), RawClusterBuilderTopo::RawClusterBuilderTopo(), nanoflann::CArray< T, N >::rbegin(), HybridHadronization::recomb(), MvtxCombinedRawDataDecoder::removeDuplicates(), KFParticle_Tools::removeDuplicates(), pq_tree::replace_pert(), Jetv1::Reset(), Jetv2::Reset(), graph::restore_edge(), graph::restore_graph(), Fun4AllHepMCInputManager::run(), Acts::PrimitivesView3DTest::run(), bellman_ford::run(), planarity::run(), planarity::run_on_biconnected(), HFTrigger::runTrigger(), HFTriggerMVA::runTrigger(), Jetscape::InitialState::SampleABinaryCollisionPoint(), graph::save(), DecayFinder::searchGeant4Record(), DecayFinder::searchHepMCRecord(), ActsFatras::Channelizer::segments(), ActsExamples::selectLayer(), ActsExamples::selectVolume(), tinyxml2::StrPair::Set(), NNH< BJ, I >::set_NN_crosscheck(), NNH< BJ, I >::set_NN_nocross(), symlist< T >::splice(), testing::internal::StringStreamToString(), nanoflann::CArray< T, N >::swap(), planarity::switch_to_component(), symlist< T >::symlist(), TEST_CASE(), PHG4GDMLWriteStructure::TraverseVolumeTree(), planarity::up_until_marked(), fm_partition::update_bucketA(), fm_partition::update_bucketB(), ratio_cut_partition::update_max_gain(), upevnt(), upinit(), ActsExamples::SensitiveSteppingAction::UserSteppingAction(), pq_tree::where_bubble_up_failed(), PHTFileServer::write(), planar_embedding::write_st(), ActsExamples::RootMaterialTrackWriter::writeT(), Acts::zip(), odbc::CleanVector< T >::~CleanVector(), and symlist< T >::~symlist().

Fluid* f

Definition at line 23 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 23 of file ctrl.cpp

Referenced by KFPMath::__attribute__(), adaptiveSimpsons(), adaptiveSimpsonsAux(), MultiArray< TVector3 >::Add(), PHG4ScintillatorSlatv1::add_edep(), KFParticleBaseSIMD::AddDaughterWithEnergyFitMC(), Acts::detail::GsfActor< bethe_heitler_approx_t, traj_t >::applyBetheHeitler(), GPUTPCTrackParam::ApproximateBetheBloch(), BEmcProfile::BEmcProfile(), GPUTPCTrackParam::BetheBlochGas(), GPUTPCTrackParam::BetheBlochGeant(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_AUTO_TEST_CASE(), BOOST_AUTO_TEST_CASE_TEMPLATE(), BOOST_DATA_TEST_CASE(), Acts::Legacy::AtlasSeedFinder< SpacePoint >::buildFrameWork(), GPUTPCTrackParam::CalculateFitParameters(), CaloTemplateFit::calo_processing_perchnl(), CaloWaveformFitting::calo_processing_templatefit(), CBcalc(), CBcalc_exp(), CBcalc_LL(), centrality_newplotbg_newsupp(), testing::internal::CallableTraits< ResType(*)(ArgType)>::CheckIsValid(), GPUTPCTrackParam::CheckNumericalQuality(), Acts::AnnulusBounds::closestOnSegment(), Jetscape::InitialState::CollectHeader(), Jetscape::HardProcess::CollectHeader(), Jetscape::FluidDynamics::CollectHeader(), KFParticleFinder::CombinePartPart(), PgPostBankBackupManager::commitAllBankfromTFile(), Acts::BoundaryCheck::computeClosestPointOnPolygon(), autodiff::detail::copysign(), GPUTPCTrackParam::CorrectForMeanMaterial(), KFParticleSIMD::Create(), Acts::SpacePointGridCreator::createGrid(), CreateHostList(), Acts::GaussianGridTrackDensity< mainGridSize, trkGridSize >::createTrackGrid(), CrossSection2RAA(), CrossSection2RAA_Proposal(), CrossSection2v2(), CrossSection2zg(), crsjet(), Packet_fvtx_dcm0::decode(), Acts::deriveEnergyLossBetheQOverP(), destroyhlle_(), SegmentationAlpide::detectorToLocalUnchecked(), ActsExamples::determineEventFilesRange(), doCompression(), ColorlessHadronization::DoHadronization(), testing::internal::DownCast_(), AZigzag::Draw(), draw_corr(), draw_G4_bjet_truth_tagging(), draw_G4_dibjet_truth_tagging(), Draw_HFJetTruth_DrawCrossSection_PR(), Draw_HFJetTruth_InvMass_DrawCrossSection_PR(), draw_hists(), DrawCalibratedE_Plot(), DrawCalibratedE_PlotTestBeam(), DrawCluster_SingleE(), DrawEcal_BlockCalibration(), DrawTower_Load(), DrawTowerSum_SingleE(), DrawTPCFEE(), oncsSub_idcaenv1742::dump(), dvcs_plot(), EdepPercentE(), EdepPercentIH(), EdepPercentOH(), EdepPercentSmall(), EMCalTowerRingStudy(), emptyTrackTest(), event_topology_reco(), EvtVtx_map_tklcluster(), Jetscape::JetScape::Exec(), ActsExamples::tbbWrap::task_arena::execute(), ExploreTTrees(), Acts::Polyhedron::extent(), ExtractRejCurve(), PgPostBankBackupManager::fetchAllBank2TFile(), PgPostBankBackupManager::fetchBank2TFile(), Acts::Legacy::AtlasSeedFinder< SpacePoint >::fillLists(), GPUTPCTrackParam::Filter(), ActsExamples::CKFPerformanceWriter::finalize(), KFParticlePVReconstructor::FindPrimaryClusters(), fit_vs_directcount(), tinyxml2::XMLElement::FloatAttribute(), tinyxml2::XMLElement::FloatText(), tinyxml2::XMLAttribute::FloatValue(), ActsExamples::Sequencer::fpeReport(), fspens(), Fun4All_EMCalLikelihood(), g(), gauss1(), gauss2(), gauss3(), gauss4(), generate_ep_dis(), MultiArray< TVector3 >::Get(), cl::detail::GetInfoHelper< Functor, T >::get(), cl::detail::GetInfoHelper< Func, VECTOR_CLASS< T > >::get(), cl::detail::GetInfoHelper< Func, VECTOR_CLASS< char * > >::get(), cl::detail::GetInfoHelper< Func, STRING_CLASS >::get(), noiGetter::get_file(), CylinderGeom_Mvtx::get_pixel_from_local_coords(), KFParticleSIMD::GetAngle(), KFParticleSIMD::GetAngleRZ(), KFParticleSIMD::GetAngleXY(), KFParticleBaseSIMD::GetArmenterosPodolanski(), GPUTPCTrackParam::GetDCAPoint(), KFParticleBaseSIMD::GetDecayLength(), KFParticleBaseSIMD::GetDecayLengthXY(), KFParticleSIMD::GetDistanceFromVertexXY(), KFParticleBaseSIMD::GetDistanceToVertexLine(), KFParticleBaseSIMD::GetDStoParticleB(), KFParticleBaseSIMD::GetDStoParticleBy(), KFParticleBase::GetDStoParticleBz(), KFParticleBaseSIMD::GetDStoParticleBz(), KFParticleBase::GetDStoParticleCBM(), KFParticleBaseSIMD::GetDStoParticleCBM(), KFParticleBaseSIMD::GetDStoParticleLine(), KFParticleBase::GetDStoPointB(), KFParticleBase::GetDStoPointBz(), KFParticleBaseSIMD::GetDStoPointBz(), KFParticleBase::GetDStoPointLine(), KFParticleBaseSIMD::GetDStoPointLine(), KFParticleBaseSIMD::GetEta(), eventReceiverClient::getEvent(), cl::detail::getInfo(), KFParticleBaseSIMD::GetMass(), Acts::GaussianGridTrackDensity< mainGridSize, trkGridSize >::getMaxZPosition(), KFParticleBase::GetMeasurement(), KFParticleBaseSIMD::GetMomentum(), GetOnePlot(), KFParticle::GetParametersAtPoint(), KFParticleBaseSIMD::GetPhi(), KFParticleBaseSIMD::GetPt(), MultiArray< TVector3 >::GetPtr(), GetQAHisto(), KFParticleBaseSIMD::GetR(), KFParticleSIMD::GetRapidity(), getResolutions(), GPUTPCTrackParam::GetS(), GetSimRejCurve(), ghvq(), gphoton(), half::half(), halfFunction< T >::halfFunction(), han(), han_BUP2020(), Hydro::hlle_flux(), Hydro::Hydro(), KFParticlePVReconstructor::Init(), KFParticleBaseSIMD::Initialize(), GPUTPCTrackParam::InitParam(), ActsFatras::detail::SimulationActor< generator_t, decay_t, interactions_t, hit_surface_selector_t >::interact(), Acts::detail::CantorEdge< int64_t >::inverse(), KFParticleBase::InvertCholetsky3(), KFParticleBaseSIMD::InvertCholetsky3(), testing::internal::CallableTraits< Callable >::Invoke(), testing::internal::CallableTraits< ResType(*)(ArgType)>::Invoke(), testing::internal::invoke_argument::InvokeArgumentAdl(), Hydro::ISformal(), Jetscape::CausalLiquefier::j_smooth(), KFPartEfficiencies::KFPartEfficiencies(), landau_quantile(), KFParticleSIMD::Load(), AnnularFieldSim::load_and_resample_spacecharge(), Load_SF(), AnnularFieldSim::load_spacecharge(), CDBTTree::LoadCalibrations(), loadTree(), Rossegger::LoadZeroes(), look_purity(), CaloCalibEmc_Pi0::Loop(), CaloCalibEmc_Pi0::Loop_for_eta_slices(), MachineLearning_CSV(), main(), make_fmod_calibrations(), makehist(), MakeOnePlot(), MakeRadiusCut(), Acts::TGeoPrimitivesHelper::match(), Acts::Material::meanExcitationEnergy(), MergeFiles(), MultiArray< TVector3 >::MultiArray(), MVTXStavePositionXY(), MyTClonesArray::MyEventFloat(), MySimpleTree::MyFloat(), KFParticleFinder::NeutralDaughterDecay(), Neutrals(), newplotbg_dAu_vscent_2022(), newplotbg_newsupp(), newplotbg_newsupp_2021(), newplotbg_newsupp_2022(), newplotbg_newsupp_2022_60pct(), newplotbg_vscent_2022(), Hydro::NSquant(), Acts::MaterialSlab::operator bool(), noiGetter::operator()(), Acts::Sycl::detail::TripletSearch::operator()(), testing::gmock_generated_actions_test::SumOf6Functor::operator()(), testing::gmock_more_actions_test::SumOf6Functor::operator()(), testing::internal::TransformTupleValuesHelper< Tuple, Func, OutIter >::IterateOverTuple< Tup, kRemainingSize >::operator()(), ActsExamples::tbbWrap::parallel_for::parallel_for(), parton(), peaks(), Hydro::performStep(), pfileopen(), plot_histos(), plot_kshort(), plot_matscan(), plot_matscan_tdr(), MakeSimpleTree::process_event(), PHG4TpcElectronDrift::process_event(), Acts::Legacy::AtlasSeedFinder< SpacePoint >::production3Sp(), genfit::Track::prune(), purity(), pycbal(), pycrth(), pyfact(), pygau2(), pygaus(), qiu_simpsons(), qiu_simpsonsRel(), ActsFatras::LandauDistribution::quantile(), Acts::KDTree< 3, int, double >::rangeSearchMap(), Acts::KDTree< 3, int, double >::rangeSearchMapDiscard(), Acts::KDTree< Dims, Type, Scalar, Vector, LeafSize >::KDTreeNode::rangeSearchMapDiscard(), Acts::KDTree< 3, int, double >::rangeSearchMapInserter(), clvisc::CLIdeal::read_ini(), PHParameters::ReadFromCDB(), PHParameters::ReadFromCDBFile(), PHParameters::ReadFromFile(), RecalibratorMakeOnePlot(), Jetscape::CausalLiquefier::rho_smooth(), ActsExamples::RootSimHitReader::RootSimHitReader(), GPUTPCTrackParam::Rotate(), ActsExamples::CsvBFieldWriter::run(), SaveCanvas(), KFParticleFinder::SaveV0PrimSecCand(), KFParticleTopoReconstructor::SelectParticleCandidates(), KFParticleFinder::SelectParticles(), MultiArray< TVector3 >::Set(), Jetv2::set_comp_sort_flag(), PHG4Hitv1::set_edep(), PHG4HitEval::set_eion(), G4RootHitContainer::set_leakage(), G4RootScintillatorTowerContainer::set_leakage(), G4RootScintillatorSlatContainer::set_leakage(), EventPlaneReco::set_MBD_Min_Qcut(), EpdGeomV1::set_phi(), set_phimin(), set_phispan(), BbcCheck::set_savefile(), MBDStudy::set_savefile(), BBCStudy::set_savefile(), PHG4Hitv1::set_t(), set_thetamin(), set_thetaspan(), PHG4Hitv1::set_x(), PHG4Hitv1::set_y(), PHG4Hitv1::set_z(), PHG4TpcElectronDrift::set_zero_bfield_diffusion_factor(), Hydro::setDtau(), mvtx::ChipPixelData::setErrorFlags(), PHNodeIOManager::setFile(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::JetInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::CstInfo::SetInfo(), KFParticleBase::SetMassConstraint(), KFParticleBaseSIMD::SetMassConstraint(), HepMCFlowAfterBurner::setMaxEta(), HepMCFlowAfterBurner::setMaxPt(), HepMCFlowAfterBurner::setMinEta(), HepMCFlowAfterBurner::setMinPt(), KFParticleBase::SetNonlinearMassConstraint(), KFParticleBaseSIMD::SetNonlinearMassConstraint(), Hydro::setNSvalues(), KFParticleBase::SetProductionVertex(), KFParticleBaseSIMD::SetProductionVertex(), ShSizePrep(), Hydro::source_step(), ActsExamples::ModuleClusters::squash(), Acts::EigenStepper< extensionlist_t, auctioneer_t >::step(), Acts::AtlasStepper::step(), testing::gmock_generated_actions_test::SumOf6(), testing::gmock_more_actions_test::SumOf6(), testing::gmock_more_actions_test::Foo::SumOf6(), Acts::Frustum< value_t, DIM, SIDES >::svg(), testing::gtest_printers_test::TEST(), TEST(), testing::gmock_generated_actions_test::TEST(), TEST_CASE(), testing::gmock_matchers_test::TEST_F(), Acts::Test::MultiTrajectoryTestsCommon< factory_t >::testMultiTrajectoryExtraColumns(), ThreeGraphs(), tileHelper::tilePattern(), TrackCaloDist(), Acts::CylinderVolumeBuilder::trackingVolume(), TrackProjection_Checks_Comparison(), transformPV(), transformPVBulk(), KFParticleBaseSIMD::TransportBz(), KFParticleBase::TransportCBM(), KFParticleBaseSIMD::TransportCBM(), KFParticleBaseSIMD::TransportToDecayVertex(), KFParticleBaseSIMD::TransportToProductionVertex(), GPUTPCTrackParam::TransportToX(), GPUTPCTrackParam::TransportToXWithMaterial(), TSCtoCDBTTree(), A_Event::updateFramelist(), vegas(), Hydro::visc_flux(), Hydro::visc_source_step(), CDBHistos::WriteCDBHistos(), CDBTTree::WriteCDBTTree(), ElossValidate::WriteTask(), ColoredHadronization::WriteTask(), ColorlessHadronization::WriteTask(), Matter::WriteTask(), HybridHadronization::WriteTask(), Jetscape::Hadronization::WriteTask(), iSpectraSamplerWrapper::WriteTask(), AdSCFT::WriteTask(), LBT::WriteTask(), Jetscape::HardProcess::WriteTask(), Jetscape::JetEnergyLoss::WriteTask(), SmashWrapper::WriteTask(), PHParameters::WriteToCDBFile(), PHParametersContainer::WriteToFile(), PdbParameterMapContainer::WriteToFile(), and PHParameters::WriteToFile().

Hydro* h

Definition at line 25 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 25 of file ctrl.cpp

Referenced by odbc::Time::_validateHour(), eic_bnl_rich::acq(), adaptiveSimpsons(), adaptiveSimpsonsAux(), Acts::Python::addUnits(), analysis(), BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_AUTO_TEST_CASE(), TpcSpaceChargeMatrixInversion::calculate_distortions(), CaloTemplateFit::calo_processing_perchnl(), CaloWaveformFitting::calo_processing_templatefit(), CentralCalorimeterRate(), Check1(), SecondaryVertexFinder::circle_circle_intersection(), compareHitHistograms(), TpcSpaceChargeReconstruction::create_histograms(), TpcClusterQA::createHistos(), Acts::Sycl::createSeedsForGroupSycl(), DataRate(), oncsSub_idfnalmwpc::decode(), oncsSub_idfnalmwpcv2::decode(), destroyhlle_(), dNdeta(), TpotMonDraw::draw_array(), TpotMonDraw::draw_detector_occupancy(), TpotMonDraw::draw_resist_occupancy(), DrawTower_Load(), DrawTPCFEE(), ElogHandler::ElogHandler(), EMCDistribution(), EMCDistribution_ADC(), EMCDistribution_Fast(), EMCDistribution_PeakSample_Fast(), EMCDistribution_SUM(), EMCDistribution_SUM_RawADC(), EMCDistributionVSBeam_SUM(), PHTpcCentralMembraneMatcher::End(), TpcSpaceChargeReconstruction::End(), QAG4SimulationMvtx::evaluate_clusters(), QAG4SimulationIntt::evaluate_clusters(), QAG4SimulationMicromegas::evaluate_clusters(), QAG4SimulationTpc::evaluate_clusters(), QAG4SimulationMicromegas::evaluate_hits(), ActsExamples::DigitizationAlgorithm::execute(), ActsExamples::FatrasSimulation::execute(), PHG4OuterHcalSteppingAction::FieldChecker(), PHG4OHCalSteppingAction::FieldChecker(), PHAna::fill_histos(), Acts::StepperExtensionList< extensions >::finalize(), ForwardCalorimeterRate(), Acts::Test::SurfaceArrayFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::LayerCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesEC(), PHG4CylinderGeom_Spacalv3::get_max_lightguide_height(), KFParticle::GetDeviationFromParticleXY(), Jetscape::Afterburner::GetFragmentationHadrons(), getMeanRMS(), GetOnePlot(), getPad(), GetQAHisto(), GetResolution(), han(), QAG4SimulationUpsilon::Init(), TpotMon::Init(), SynRadAna::Init(), QAG4SimulationDistortions::Init(), QAG4SimulationVertex::Init(), QAG4SimulationCalorimeter::Init(), QAG4SimulationKFParticle::Init(), QAG4SimulationTracking::Init(), Proto4SampleFrac::Init(), QAG4SimulationCalorimeterSum::Init(), QAG4SimulationTruthDecay::Init(), truthDecayTester::Init(), QAG4Decayer::Init(), QAG4SimulationCalorimeter::Init_G4Hit(), QAG4SimulationJet::Init_Spectrum(), SoftLeptonTaggingTruth::Init_Spectrum(), QAG4SimulationCalorimeter::Init_Tower(), QAG4SimulationJet::Init_TruthMatching(), TPCIntegratedCharge::InitRun(), QAG4SimulationMvtx::InitRun(), QAG4SimulationIntt::InitRun(), QAG4SimulationMicromegas::InitRun(), QAG4SimulationTpc::InitRun(), TPCDataStreamEmulator::InitRun(), PHG4ScoringManager::InitRun(), TPCMLDataInterface::InitRun(), TPCFEETestRecov1::InitRun(), TpcPrototypeUnpacker::InitRun(), JetHepMCLoader::InitRun(), Acts::AutodiffExtensionWrapper< basic_extension_t >::k(), Acts::detail::GenericDefaultExtension< scalar_t >::k(), Acts::StepperExtensionList< extensions >::k(), Acts::detail::GenericDenseEnvironmentExtension< scalar_t >::k(), PHG4Utils::lines_intersect(), CaloValid::LogYHist2D(), LogYHist2D(), look_purity(), main(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrelStagger(), Acts::Test::LayerCreatorFixture::makeBarrelStagger(), MakeChipMultiplicitySet(), Acts::AnyBase< ACTS_SOURCELINK_SBO_SIZE >::makeHandler(), PHG4ScoringManager::makeScoringHistograms(), mg_cgi_ev_handler(), mg_get_http_header(), mg_prepare_cgi_environment(), mg_resolve2(), half::negInf(), odeint(), std::hash< std::array< T, N > >::operator()(), half::operator-(), peaks(), Conversion::PHG4VtxPointToSvtxVertex(), Plot_Hit_Count(), Plot_Measured_Energy_EMC(), half::posInf(), PositionDependenceData(), PositionDependenceSim(), Jetscape::HadronPrinter::PrintFinalHadron(), TpcClusterQA::process_event(), TpotMon::process_event(), HCalib::process_event(), Proto4SampleFrac::process_event(), PHTpcCentralMembraneMatcher::process_event(), QAG4SimulationCalorimeter::process_event_Cluster(), QAG4SimulationCalorimeter::process_event_G4Hit(), EMCalAna::process_event_SF(), EMCalCalib::process_event_SF(), QAG4SimulationCalorimeter::process_event_Tower(), EMCalAna::process_event_Tower(), EMCalCalib::process_event_Tower(), proj(), pycrth(), pygau2(), pygaus(), pysimp(), half::qNan(), RecalibratorMakeOnePlot(), reconstructionPerformance(), removeFirstBin(), TpotMon::Reset(), Fun4AllHistoManager::Reset(), rk4step(), rkstepper(), half::round(), sccalib(), SectorDataSize(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::JetInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::CstInfo::SetInfo(), KFParticleBase::SetNoDecayLength(), KFParticleBaseSIMD::SetNoDecayLength(), ActsExamples::WhiteBoard::similarNames(), half::sNan(), sPHENIXplots(), TpcSpaceChargeReconstructionHelper::split(), spmcalib(), Acts::detail_vmt::VectorMultiTrajectoryBase::statistics(), Acts::StraightLineStepper::step(), Acts::EigenStepper< extensionlist_t, auctioneer_t >::step(), Acts::AtlasStepper::step(), Matter::sud_val_GG(), Matter::sud_val_QG(), epemGun::sud_val_QG_w_M(), Matter::sud_val_QG_w_M(), Matter::sud_val_QP(), Matter::sud_val_QQ(), Matter::sud_val_QQ_w_M_vac_only(), Acts::Test::MultiTrajectoryTestsCommon< factory_t >::testMultiTrajectoryExtraColumns(), Acts::detail_vmt::VectorMultiTrajectoryBase::Statistics::toStream(), track_calorimeter_matching(), TrackerRate(), Acts::detail::GenericDefaultExtension< scalar_t >::transportMatrix(), Acts::detail::GenericDenseEnvironmentExtension< scalar_t >::transportMatrix(), TriggerMultiplicity(), upsilon_raa_sphenix_estimator(), ActsExamples::SensitiveSteppingAction::UserSteppingAction(), Acts::RiddersPropagator< propagator_t >::wiggleParameter(), and Jetscape::Hadronization::WriteTask().

IC_KW* ic_kw

Definition at line 24 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 24 of file ctrl.cpp

Referenced by icgethlle3f_(), icgethlle_(), and initichlle_().

int maxstep

Definition at line 29 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 29 of file ctrl.cpp

Referenced by getmaxstephlle_(), inithydrohlle_(), initoutputhlle_(), and main().

ofstream ofile

Definition at line 19 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 19 of file ctrl.cpp

Referenced by destroyhlle_(), main(), redirecterrorshlle_(), runCCPi0Loop(), runLCELoop(), save_corr_value2(), save_correc_value(), Langevin::SaveMaps(), QPileUp::SaveMaps(), and FieldMaps::SaveMaps().

time_t start

Definition at line 26 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 26 of file ctrl.cpp

Referenced by ClosestPair2D::_initialize(), AnnularFieldSim::analyticFieldIntegral(), PHG4TpcDirectLaser::AppendLaserTrack(), Acts::Test::basicChecks(), PHField3DCylindrical::bin_search(), BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), ActsFatras::BOOST_DATA_TEST_CASE(), CalculateSigmaDca(), centrality_newplotbg_newsupp(), compare(), crossterms(), destroyhlle_(), doCompression(), CemcMonDraw::DrawFirst(), CemcMonDraw::DrawFourth(), CemcMonDraw::DrawSecond(), CemcMonDraw::DrawThird(), fakee_invmass(), AnnularFieldSim::fieldIntegral(), FindBlobs(), ActsExamples::GroupBy< Iterator, KeyGetter >::findEndOfGroup(), KFParticle_Tools::findUniqueDaughterCombinations(), AnnularFieldSim::GetStepDistortion(), gettimehlle_(), AnnularFieldSim::GetTotalDistortion(), tinyxml2::XMLDocument::Identify(), inithydrohlle_(), PhDi::Integral(), main(), Acts::SurfaceMaterialMapper::mapInteraction(), Acts::VolumeMaterialMapper::mapMaterialTrack(), mg_sock_addr_to_str(), Acts::Test::benchmark_tools_internal::microBenchmarkImpl(), newplotbg_dAu_vscent_2022(), newplotbg_newsupp(), newplotbg_newsupp_2021(), newplotbg_newsupp_2022(), newplotbg_newsupp_2022_60pct(), newplotbg_vscent_2022(), PgPostCalBankIterator::next(), Fatras::Simulator< charged_propagator_t, charged_selector_t, charged_interactor_t, neutral_propagator_t, neutral_selector_t, neutral_interactor_t >::operator()(), tinyxml2::XMLElement::ParseAttributes(), tinyxml2::XMLText::ParseDeep(), tinyxml2::XMLComment::ParseDeep(), tinyxml2::XMLDeclaration::ParseDeep(), tinyxml2::XMLUnknown::ParseDeep(), tinyxml2::StrPair::ParseName(), tinyxml2::StrPair::ParseText(), Acts::RiddersPropagator< propagator_t >::propagate(), Acts::Propagator< stepper_t, navigator_t >::propagate(), genfit::MplTrackRep::RKPropagate(), genfit::RKTrackRep::RKPropagate(), Acts::PrimitivesView3DTest::run(), testing::TestCase::Run(), testing::internal::UnitTestImpl::RunAllTests(), OnlMonHtml::runRange(), Acts::Test::runTest(), ActsFatras::Channelizer::segments(), tinyxml2::StrPair::Set(), bfs::start_node(), dfs::start_node(), HybridHadronization::stringform(), AnnularFieldSim::swimToInAnalyticSteps(), FitterTester::test_GlobalCovariance(), FitterTester::test_ZeroFieldNoSurfaceForward(), FitterTester::test_ZeroFieldShuffled(), FitterTester::test_ZeroFieldWithHole(), FitterTester::test_ZeroFieldWithOutliers(), FitterTester::test_ZeroFieldWithReverseFiltering(), FitterTester::test_ZeroFieldWithSurfaceAtExit(), FitterTester::test_ZeroFieldWithSurfaceForward(), MinHeap::update(), Acts::RiddersPropagator< propagator_t >::wiggleAndCalculateJacobian(), Acts::detail::wrap_periodic(), ActsExamples::RootMaterialTrackWriter::writeT(), and xPositionsOfPassedSurfaces().

double tau_max

Definition at line 28 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 28 of file ctrl.cpp

Referenced by inithydrohlle_(), and Hydroinfo_MUSIC::update_grid_info().

TransportCoeff* trcoeff

Definition at line 22 of file ctrl.cpp.

View newest version in sPHENIX GitHub at line 22 of file ctrl.cpp

Referenced by Fluid::calcTotals(), Fluid::Fluid(), Hydro::Hydro(), Hydro::ISformal(), main(), Hydro::NSquant(), Hydro::performStep(), and Hydro::setNSvalues().