EIC Software
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
PHG4TrackFastSim Class Reference

#include <fun4all_coresoftware/blob/master/simulation/g4simulation/g4trackfastsim/PHG4TrackFastSim.h>

+ Inheritance diagram for PHG4TrackFastSim:
+ Collaboration diagram for PHG4TrackFastSim:

Public Types

enum  DETECTOR_TYPE { Vertical_Plane = 0, Cylinder = 1 }
 

Public Member Functions

 PHG4TrackFastSim (const std::string &name="PHG4TrackFastSim")
 Default constructor.
 
 ~PHG4TrackFastSim () override
 dtor
 
int InitRun (PHCompositeNode *) override
 Initialization Run, called for initialization of a run.
 
int process_event (PHCompositeNode *) override
 Process Event, called for each event.
 
int End (PHCompositeNode *) override
 End, write and close files.
 
bool is_do_evt_display () const
 
void set_do_evt_display (bool doEvtDisplay)
 
const std::string & get_fit_alg_name () const
 
void set_fit_alg_name (const std::string &fitAlgName)
 
const std::vector< std::string > & get_phg4hits_names () const
 
void add_phg4hits (const std::string &phg4hitsNames, const DETECTOR_TYPE phg4dettype, const float radres, const float phires, const float lonres, const float eff, const float noise)
 
void add_state_name (const std::string &stateName)
 
void add_zplane_state (const std::string &stateName, const double zplane)
 
void add_cylinder_state (const std::string &stateName, const double radius)
 
const std::string & get_trackmap_out_name () const
 
void set_trackmap_out_name (const std::string &trackmapOutName)
 
const std::string & get_sub_top_node_name () const
 
void set_sub_top_node_name (const std::string &subTopNodeName)
 
bool is_use_vertex_in_fitting () const
 
void set_use_vertex_in_fitting (bool useVertexInFitting)
 
double get_vertex_xy_resolution () const
 
void set_vertex_xy_resolution (double vertexXyResolution)
 
double get_vertex_z_resolution () const
 
void set_vertex_z_resolution (double vertexZResolution)
 
int get_primary_assumption_pid () const
 
void set_primary_assumption_pid (int primaryAssumptionPid)
 
void set_primary_tracking (int pTrk)
 
const std::string & get_vertexing_method () const
 https://rave.hepforge.org/trac/wiki/RaveMethods
 
void set_vertexing_method (const std::string &vertexingMethod)
 https://rave.hepforge.org/trac/wiki/RaveMethods
 
double get_vertex_min_ndf () const
 
void set_vertex_min_ndf (double vertexMinNdf)
 
void enable_vertexing (const bool &b=true)
 
void DisplayEvent () const
 
void Smearing (const bool b)
 
- Public Member Functions inherited from SubsysReco
 ~SubsysReco () override
 
virtual int EndRun (const int)
 Called at the end of each run.
 
virtual int Init (PHCompositeNode *)
 
virtual int Reset (PHCompositeNode *)
 Reset.
 
virtual int ResetEvent (PHCompositeNode *)
 Clean up after each event.
 
void Print (const std::string &="ALL") const override
 
- Public Member Functions inherited from Fun4AllBase
virtual ~Fun4AllBase ()
 
virtual const std::string Name () const
 Returns the name of this module.
 
virtual void Name (const std::string &name)
 Sets the name of this module.
 
virtual void Verbosity (const int ival)
 Sets the verbosity of this module (0 by default=quiet).
 
virtual void Verbosity (enu_Verbosity ival)
 Sets the verbosity of this module (0 by default=quiet).
 
virtual int Verbosity () const
 Gets the verbosity of this module.
 

Protected Attributes

gsl_rng * m_RandomGenerator
 random generator that conform with sPHENIX standard
 
PHGenFit::Fitterm_Fitter
 
genfit::GFRaveVertexFactorym_RaveVertexFactory
 
PHG4TruthInfoContainerm_TruthContainer
 Input Node pointers.
 
SvtxTrackMapm_SvtxTrackMapOut
 
SvtxVertexMapm_SvtxVertexMap
 
std::vector< PHG4HitContainer * > m_PHG4HitContainer
 
std::vector< std::string > m_PHG4HitsNames
 
std::vector< DETECTOR_TYPEm_phg4_detector_type
 
std::vector< float > m_phg4_detector_radres
 
std::vector< float > m_phg4_detector_phires
 
std::vector< float > m_phg4_detector_lonres
 
std::vector< float > m_phg4_detector_hitfindeff
 
std::vector< float > m_phg4_detector_noise
 
std::map< std::string,
std::pair< int, double > > 
m_ProjectionsMap
 
std::string m_SubTopnodeName
 
std::string m_TrackmapOutNodeName
 
std::string m_VertexingMethod
 https://rave.hepforge.org/trac/wiki/RaveMethods
 
std::string m_FitAlgoName
 
double m_VertexMinNdf
 
double m_VertexXYResolution
 
double m_VertexZResolution
 
int m_EventCnt
 Event counter.
 
int m_PrimaryAssumptionPid
 
bool m_SmearingFlag
 
bool m_DoEvtDisplayFlag
 
bool m_UseVertexInFittingFlag
 
int m_PrimaryTrackingFlag
 
bool m_DoVertexingFlag
 
PHParametersm_Parameter = nullptr
 

Private Types

typedef std::map< const
genfit::Track *, unsigned int > 
GenFitTrackMap
 

Private Member Functions

int CreateNodes (PHCompositeNode *)
 
int GetNodes (PHCompositeNode *)
 
int PseudoPatternRecognition (const PHG4Particle *particle, std::vector< PHGenFit::Measurement * > &meas_out, SvtxTrack *track_out, TVector3 &seed_pos, TVector3 &seed_mom, TMatrixDSym &seed_cov, const bool do_smearing=true)
 
PHGenFit::PlanarMeasurementPHG4HitToMeasurementVerticalPlane (const PHG4Hit *g4hit, const double phi_resolution, const double r_resolution)
 
PHGenFit::PlanarMeasurementPHG4HitToMeasurementCylinder (const PHG4Hit *g4hit, const double phi_resolution, const double z_resolution)
 
PHGenFit::MeasurementVertexMeasurement (const TVector3 &vtx, double dxy, double dz)
 
bool MakeSvtxTrack (SvtxTrack *track_out, const PHGenFit::Track *phgf_track_in, const unsigned int truth_track_id=UINT_MAX, const unsigned int nmeas=0, const TVector3 &vtx=TVector3(0.0, 0.0, 0.0))
 
bool FillSvtxVertexMap (const std::vector< genfit::GFRaveVertex * > &rave_vertices, const GenFitTrackMap &gf_tracks)
 

Additional Inherited Members

- Protected Member Functions inherited from SubsysReco
 SubsysReco (const std::string &name="NONAME")
 

Detailed Description

Definition at line 54 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 54 of file PHG4TrackFastSim.h

Member Typedef Documentation

typedef std::map<const genfit::Track*, unsigned int> PHG4TrackFastSim::GenFitTrackMap
private

Definition at line 235 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 235 of file PHG4TrackFastSim.h

Member Enumeration Documentation

Enumerator:
Vertical_Plane 
Cylinder 

Definition at line 57 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 57 of file PHG4TrackFastSim.h

Constructor & Destructor Documentation

PHG4TrackFastSim::PHG4TrackFastSim ( const std::string &  name = "PHG4TrackFastSim")
explicit

Default constructor.

Definition at line 104 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 104 of file PHG4TrackFastSim.cc

References m_Parameter, m_RandomGenerator, and Fun4AllBase::Name().

+ Here is the call graph for this function:

PHG4TrackFastSim::~PHG4TrackFastSim ( )
override

dtor

Definition at line 133 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 133 of file PHG4TrackFastSim.cc

References m_Fitter, m_RandomGenerator, and m_RaveVertexFactory.

Member Function Documentation

void PHG4TrackFastSim::add_cylinder_state ( const std::string &  stateName,
const double  radius 
)

Definition at line 1120 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 1120 of file PHG4TrackFastSim.cc

References m_ProjectionsMap, PHWHERE, reserved_cylinder_projection_names, and reserved_zplane_projection_names.

Referenced by Fun4All_G4_FastMom(), Fun4All_G4_FastMom_GEM(), Fun4All_G4_FastMom_GEM_RICH(), Fun4All_G4_Momentum_Projection(), and Fun4All_G4_Momentum_Projection_Detectors().

+ Here is the caller graph for this function:

void PHG4TrackFastSim::add_phg4hits ( const std::string &  phg4hitsNames,
const DETECTOR_TYPE  phg4dettype,
const float  radres,
const float  phires,
const float  lonres,
const float  eff,
const float  noise 
)
inline

adding hits from a PHG4Hit node, which usually belong to one detector or a sub group of detectors Orders of adding detectors do not matter as the hits are internally assembled in the time order

Parameters
[in]phg4hitsNamesnode name such as "G4HIT_SVTX"
[in]PHG4TrackFastSim::Vertical_Planeor PHG4TrackFastSim::Cylinder
[in]radresradial resolution [cm], not used for PHG4TrackFastSim::Cylinder
[in]phiresazimuthal resolution [cm]
[in]lonresz-resolution [cm], not used for PHG4TrackFastSim::Vertical_Plane
[in]effEfficiency [0-1] for a existing hit to be included in the tracking
[in]noiseNoise hit propability [0-1]

Definition at line 112 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 112 of file PHG4TrackFastSim.h

References m_phg4_detector_hitfindeff, m_phg4_detector_lonres, m_phg4_detector_noise, m_phg4_detector_phires, m_phg4_detector_radres, m_phg4_detector_type, and m_PHG4HitsNames.

Referenced by add_AllSi_to_kalman(), FGEM_FastSim_Reco(), Fun4All_G4_FastMom_GEM(), Fun4All_G4_FastMom_GEM_RICH(), Fun4All_G4_Momentum(), Fun4All_G4_Momentum_Projection(), Fun4All_G4_Momentum_Projection_Calorimeters(), Fun4All_G4_Momentum_Projection_Detectors(), Fun4All_G4_simple_hadron(), Fun4All_G4_simple_hadron_GEM(), Fun4All_G4_simple_vertex(), Fun4All_G4_simplified_3vtx(), Fun4All_G4_simplified_v2(), Fun4All_G4_simplified_v2_DIRC_barrel_GEM(), and Tracking_Reco().

+ Here is the caller graph for this function:

void PHG4TrackFastSim::add_state_name ( const std::string &  stateName)

Definition at line 1090 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 1090 of file PHG4TrackFastSim.cc

References m_ProjectionsMap, PHWHERE, reserved_cylinder_projection_names, and reserved_zplane_projection_names.

Referenced by FGEM_FastSim_Reco(), Fun4All_G4_Momentum_Projection_Calorimeters(), and Tracking_Reco().

+ Here is the caller graph for this function:

void PHG4TrackFastSim::add_zplane_state ( const std::string &  stateName,
const double  zplane 
)

Definition at line 1137 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 1137 of file PHG4TrackFastSim.cc

References m_ProjectionsMap, PHWHERE, reserved_cylinder_projection_names, and reserved_zplane_projection_names.

Referenced by Fun4All_G4_FastMom(), Fun4All_G4_FastMom_GEM(), Fun4All_G4_FastMom_GEM_RICH(), Fun4All_G4_Momentum_Projection(), Fun4All_G4_Momentum_Projection_Detectors(), and Tracking_Reco().

+ Here is the caller graph for this function:

int PHG4TrackFastSim::CreateNodes ( PHCompositeNode topNode)
private

Create needed nodes.

Definition at line 548 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 548 of file PHG4TrackFastSim.cc

References Fun4AllReturnCodes::ABORTEVENT, PHCompositeNode::addNode(), Fun4AllReturnCodes::EVENT_OK, PHNodeIterator::findFirst(), m_SubTopnodeName, m_SvtxTrackMapOut, m_SvtxVertexMap, m_TrackmapOutNodeName, PHWHERE, and Fun4AllBase::Verbosity().

Referenced by InitRun().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void PHG4TrackFastSim::DisplayEvent ( ) const

Definition at line 1081 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 1081 of file PHG4TrackFastSim.cc

References PHGenFit::Fitter::displayEvent(), m_DoEvtDisplayFlag, and m_Fitter.

+ Here is the call graph for this function:

void PHG4TrackFastSim::enable_vertexing ( const bool &  b = true)
inline

Definition at line 225 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 225 of file PHG4TrackFastSim.h

References m_DoVertexingFlag.

Referenced by Fun4All_G4_FastMom(), Fun4All_G4_FastMom_GEM(), Fun4All_G4_FastMom_GEM_RICH(), Fun4All_G4_simple_vertex(), Fun4All_G4_simplified_3vtx(), Fun4All_G4_simplified_v2(), Fun4All_G4_simplified_v2_DIRC_barrel_GEM(), and Tracking_Reco().

+ Here is the caller graph for this function:

int PHG4TrackFastSim::End ( PHCompositeNode )
overridevirtual

End, write and close files.

Reimplemented from SubsysReco.

Definition at line 235 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 235 of file PHG4TrackFastSim.cc

References PHGenFit::Fitter::displayEvent(), Fun4AllReturnCodes::EVENT_OK, m_DoEvtDisplayFlag, and m_Fitter.

+ Here is the call graph for this function:

bool PHG4TrackFastSim::FillSvtxVertexMap ( const std::vector< genfit::GFRaveVertex * > &  rave_vertices,
const GenFitTrackMap gf_tracks 
)
private

Definition at line 490 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 490 of file PHG4TrackFastSim.cc

References SvtxVertexMap::insert_clone(), LogError, m_SvtxVertexMap, and PHWHERE.

Referenced by process_event().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

const std::string& PHG4TrackFastSim::get_fit_alg_name ( ) const
inline

Definition at line 88 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 88 of file PHG4TrackFastSim.h

References m_FitAlgoName.

const std::vector<std::string>& PHG4TrackFastSim::get_phg4hits_names ( ) const
inline

Definition at line 98 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 98 of file PHG4TrackFastSim.h

References m_PHG4HitsNames.

int PHG4TrackFastSim::get_primary_assumption_pid ( ) const
inline

Definition at line 188 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 188 of file PHG4TrackFastSim.h

References m_PrimaryAssumptionPid.

const std::string& PHG4TrackFastSim::get_sub_top_node_name ( ) const
inline

Definition at line 148 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 148 of file PHG4TrackFastSim.h

References m_SubTopnodeName.

const std::string& PHG4TrackFastSim::get_trackmap_out_name ( ) const
inline

Definition at line 138 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 138 of file PHG4TrackFastSim.h

References m_TrackmapOutNodeName.

double PHG4TrackFastSim::get_vertex_min_ndf ( ) const
inline

Definition at line 215 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 215 of file PHG4TrackFastSim.h

References m_VertexMinNdf.

double PHG4TrackFastSim::get_vertex_xy_resolution ( ) const
inline

Definition at line 168 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 168 of file PHG4TrackFastSim.h

References m_VertexXYResolution.

double PHG4TrackFastSim::get_vertex_z_resolution ( ) const
inline

Definition at line 178 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 178 of file PHG4TrackFastSim.h

References m_VertexZResolution.

const std::string& PHG4TrackFastSim::get_vertexing_method ( ) const
inline

https://rave.hepforge.org/trac/wiki/RaveMethods

Definition at line 204 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 204 of file PHG4TrackFastSim.h

References m_VertexingMethod.

int PHG4TrackFastSim::GetNodes ( PHCompositeNode topNode)
private

Get all the all the required nodes off the node tree.

Definition at line 610 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 610 of file PHG4TrackFastSim.cc

References Fun4AllReturnCodes::ABORTEVENT, Fun4AllReturnCodes::EVENT_OK, PHNodeIterator::findFirst(), PHG4HitContainer::GetID(), PHObject::identify(), m_EventCnt, m_FitAlgoName, m_Parameter, m_phg4_detector_hitfindeff, m_phg4_detector_lonres, m_phg4_detector_noise, m_phg4_detector_phires, m_phg4_detector_radres, m_phg4_detector_type, m_PHG4HitContainer, m_PHG4HitsNames, m_SubTopnodeName, m_SvtxTrackMapOut, m_TrackmapOutNodeName, m_TruthContainer, m_VertexingMethod, Fun4AllBase::Name(), PHWHERE, PHParameters::SaveToNodeTree(), PHParameters::set_int_param(), PHParameters::set_string_param(), and Fun4AllBase::Verbosity().

Referenced by InitRun().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

int PHG4TrackFastSim::InitRun ( PHCompositeNode topNode)
overridevirtual
bool PHG4TrackFastSim::is_do_evt_display ( ) const
inline

Definition at line 78 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 78 of file PHG4TrackFastSim.h

References m_DoEvtDisplayFlag.

bool PHG4TrackFastSim::is_use_vertex_in_fitting ( ) const
inline

Definition at line 158 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 158 of file PHG4TrackFastSim.h

References m_UseVertexInFittingFlag.

bool PHG4TrackFastSim::MakeSvtxTrack ( SvtxTrack track_out,
const PHGenFit::Track phgf_track_in,
const unsigned int  truth_track_id = UINT_MAX,
const unsigned int  nmeas = 0,
const TVector3 &  vtx = TVector3(0.0, 0.0, 0.0) 
)
private

Make SvtxTrack from PHGenFit::Track

TODO: check the definition 1/p, u'/z', v'/z', u, v u is defined as mom X beam line at POCA so u is the dca2d direction

Definition at line 865 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 865 of file PHG4TrackFastSim.cc

References SvtxTrack::begin_states(), Acts::Test::cov, PHGenFit::Track::extrapolateToCylinder(), PHGenFit::Track::extrapolateToLine(), PHGenFit::Track::extrapolateToPlane(), genfit::MeasuredStateOnPlane::get6DCov(), PHGenFit::Track::get_charge(), PHGenFit::Track::get_chi2(), PHGenFit::Track::get_ndf(), genfit::MeasuredStateOnPlane::getCov(), genfit::StateOnPlane::getMom(), genfit::StateOnPlane::getPos(), genfit::StateOnPlane::getState(), SvtxTrack::insert_state(), LogError, m_ProjectionsMap, charm_jet_coverage::mom, pos(), SvtxTrack::set_charge(), SvtxTrack::set_chisq(), SvtxTrack::set_dca(), SvtxTrack::set_dca2d(), SvtxTrack::set_dca2d_error(), SvtxTrackState::set_error(), SvtxTrack::set_error(), SvtxTrackState::set_name(), SvtxTrack::set_ndf(), SvtxTrack::set_num_measurements(), SvtxTrackState::set_px(), SvtxTrack::set_px(), SvtxTrackState::set_py(), SvtxTrack::set_py(), SvtxTrackState::set_pz(), SvtxTrack::set_pz(), SvtxTrack::set_truth_track_id(), SvtxTrackState::set_x(), SvtxTrack::set_x(), SvtxTrackState::set_y(), SvtxTrack::set_y(), SvtxTrackState::set_z(), SvtxTrack::set_z(), and Fun4AllBase::Verbosity().

Referenced by process_event().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

PHGenFit::PlanarMeasurement * PHG4TrackFastSim::PHG4HitToMeasurementCylinder ( const PHG4Hit g4hit,
const double  phi_resolution,
const double  z_resolution 
)
private

Definition at line 1027 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 1027 of file PHG4TrackFastSim.cc

References PHG4Hit::get_avg_x(), PHG4Hit::get_avg_y(), PHG4Hit::get_avg_z(), m_RandomGenerator, m_SmearingFlag, pos(), Acts::UnitConstants::u, and v.

Referenced by PseudoPatternRecognition().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

PHGenFit::PlanarMeasurement * PHG4TrackFastSim::PHG4HitToMeasurementVerticalPlane ( const PHG4Hit g4hit,
const double  phi_resolution,
const double  r_resolution 
)
private

Definition at line 991 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 991 of file PHG4TrackFastSim.cc

References PHG4Hit::get_avg_x(), PHG4Hit::get_avg_y(), PHG4Hit::get_avg_z(), m_RandomGenerator, m_SmearingFlag, pos(), Acts::UnitConstants::u, and v.

Referenced by PseudoPatternRecognition().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

int PHG4TrackFastSim::process_event ( PHCompositeNode )
overridevirtual

Process Event, called for each event.

Create measurements

Build TrackRep from particle assumption

mu+: -13 mu-: 13 pi+: 211 pi-: -211 e-: 11 e+: -11

Initialize track with seed from pattern recognition

Add measurements to track

Fit the track

add tracks to event display

Reimplemented from SubsysReco.

Definition at line 245 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 245 of file PHG4TrackFastSim.cc

References Fun4AllReturnCodes::ABORTRUN, genfit::EventDisplay::addEvent(), PHGenFit::Track::addMeasurements(), Acts::Test::cov, Fun4AllReturnCodes::EVENT_OK, FillSvtxVertexMap(), genfit::GFRaveVertexFactory::findVertices(), PHG4Particle::get_track_id(), PHG4VtxPoint::get_x(), PHG4VtxPoint::get_y(), PHG4VtxPoint::get_z(), genfit::FitStatus::getCharge(), genfit::FitStatus::getChi2(), PHGenFit::Fitter::getEventDisplay(), genfit::Track::getFitStatus(), genfit::Track::getFittedState(), PHGenFit::Track::getGenFitTrack(), genfit::FitStatus::getNdf(), PHG4TruthInfoContainer::GetParticleRange(), genfit::MeasuredStateOnPlane::getPosMomCov(), PHG4TruthInfoContainer::GetPrimaryParticleRange(), PHG4TruthInfoContainer::GetPrimaryVertexIndex(), PHG4TruthInfoContainer::GetPrimaryVtx(), SvtxTrack::identify(), it, LogError, m_DoEvtDisplayFlag, m_DoVertexingFlag, m_EventCnt, m_Fitter, m_PrimaryAssumptionPid, m_PrimaryTrackingFlag, m_RandomGenerator, m_RaveVertexFactory, m_SvtxTrackMapOut, m_SvtxVertexMap, m_TruthContainer, m_UseVertexInFittingFlag, m_VertexMinNdf, m_VertexXYResolution, m_VertexZResolution, MakeSvtxTrack(), charm_jet_coverage::mom, particle, PHWHERE, pos(), PHGenFit::Fitter::processTrack(), PseudoPatternRecognition(), Fun4AllBase::Verbosity(), VertexMeasurement(), and vtx().

+ Here is the call graph for this function:

int PHG4TrackFastSim::PseudoPatternRecognition ( const PHG4Particle particle,
std::vector< PHGenFit::Measurement * > &  meas_out,
SvtxTrack track_out,
TVector3 &  seed_pos,
TVector3 &  seed_mom,
TMatrixDSym &  seed_cov,
const bool  do_smearing = true 
)
private

Definition at line 695 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 695 of file PHG4TrackFastSim.cc

References Fun4AllReturnCodes::ABORTEVENT, SvtxTrack::add_g4hit_id(), Cylinder, Fun4AllReturnCodes::EVENT_OK, PHG4Hit::get_avg_t(), PHG4Hit::get_hit_id(), PHG4Particle::get_px(), PHG4Particle::get_py(), PHG4Particle::get_pz(), PHG4Particle::get_track_id(), PHG4Hit::get_trkid(), PHG4Particle::identify(), PHG4Hit::identify(), LogDebug, LogError, m_phg4_detector_hitfindeff, m_phg4_detector_lonres, m_phg4_detector_noise, m_phg4_detector_phires, m_phg4_detector_radres, m_phg4_detector_type, m_PHG4HitContainer, m_PHG4HitsNames, M_PI, m_RandomGenerator, PHG4HitToMeasurementCylinder(), PHG4HitToMeasurementVerticalPlane(), Fun4AllBase::Verbosity(), and Vertical_Plane.

Referenced by process_event().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void PHG4TrackFastSim::set_do_evt_display ( bool  doEvtDisplay)
inline

Definition at line 83 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 83 of file PHG4TrackFastSim.h

References m_DoEvtDisplayFlag.

void PHG4TrackFastSim::set_fit_alg_name ( const std::string &  fitAlgName)
inline

Definition at line 93 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 93 of file PHG4TrackFastSim.h

References m_FitAlgoName.

void PHG4TrackFastSim::set_primary_assumption_pid ( int  primaryAssumptionPid)
inline

Definition at line 193 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 193 of file PHG4TrackFastSim.h

References m_PrimaryAssumptionPid.

Referenced by Fun4All_G4_simplified_3vtx().

+ Here is the caller graph for this function:

void PHG4TrackFastSim::set_primary_tracking ( int  pTrk)
inline

Definition at line 198 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 198 of file PHG4TrackFastSim.h

References m_PrimaryTrackingFlag.

void PHG4TrackFastSim::set_sub_top_node_name ( const std::string &  subTopNodeName)
inline
void PHG4TrackFastSim::set_trackmap_out_name ( const std::string &  trackmapOutName)
inline
void PHG4TrackFastSim::set_use_vertex_in_fitting ( bool  useVertexInFitting)
inline
void PHG4TrackFastSim::set_vertex_min_ndf ( double  vertexMinNdf)
inline

Definition at line 220 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 220 of file PHG4TrackFastSim.h

References m_VertexMinNdf.

Referenced by Fun4All_G4_FastMom(), Fun4All_G4_FastMom_GEM(), Fun4All_G4_FastMom_GEM_RICH(), Fun4All_G4_simple_vertex(), Fun4All_G4_simplified_3vtx(), Fun4All_G4_simplified_v2(), and Fun4All_G4_simplified_v2_DIRC_barrel_GEM().

+ Here is the caller graph for this function:

void PHG4TrackFastSim::set_vertex_xy_resolution ( double  vertexXyResolution)
inline

Definition at line 173 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 173 of file PHG4TrackFastSim.h

References m_VertexXYResolution.

Referenced by FGEM_FastSim_Reco(), Fun4All_G4_FastMom(), Fun4All_G4_FastMom_GEM(), Fun4All_G4_FastMom_GEM_RICH(), Fun4All_G4_simple_vertex(), Fun4All_G4_simplified_3vtx(), Fun4All_G4_simplified_v2(), Fun4All_G4_simplified_v2_DIRC_barrel_GEM(), and Tracking_Reco().

+ Here is the caller graph for this function:

void PHG4TrackFastSim::set_vertex_z_resolution ( double  vertexZResolution)
inline

Definition at line 183 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 183 of file PHG4TrackFastSim.h

References m_VertexZResolution.

Referenced by FGEM_FastSim_Reco(), Fun4All_G4_FastMom(), Fun4All_G4_FastMom_GEM(), Fun4All_G4_FastMom_GEM_RICH(), Fun4All_G4_simple_vertex(), Fun4All_G4_simplified_3vtx(), Fun4All_G4_simplified_v2(), Fun4All_G4_simplified_v2_DIRC_barrel_GEM(), and Tracking_Reco().

+ Here is the caller graph for this function:

void PHG4TrackFastSim::set_vertexing_method ( const std::string &  vertexingMethod)
inline

https://rave.hepforge.org/trac/wiki/RaveMethods

Definition at line 210 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 210 of file PHG4TrackFastSim.h

References m_VertexingMethod.

void PHG4TrackFastSim::Smearing ( const bool  b)
inline

Definition at line 232 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 232 of file PHG4TrackFastSim.h

References m_SmearingFlag.

PHGenFit::Measurement * PHG4TrackFastSim::VertexMeasurement ( const TVector3 &  vtx,
double  dxy,
double  dz 
)
private

Definition at line 1063 of file PHG4TrackFastSim.cc.

View newest version in sPHENIX GitHub at line 1063 of file PHG4TrackFastSim.cc

References Acts::Test::cov, dz, pos(), and vtx().

Referenced by process_event().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

Member Data Documentation

bool PHG4TrackFastSim::m_DoEvtDisplayFlag
protected

Definition at line 332 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 332 of file PHG4TrackFastSim.h

Referenced by DisplayEvent(), End(), InitRun(), is_do_evt_display(), process_event(), and set_do_evt_display().

bool PHG4TrackFastSim::m_DoVertexingFlag
protected

Definition at line 343 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 343 of file PHG4TrackFastSim.h

Referenced by enable_vertexing(), InitRun(), and process_event().

int PHG4TrackFastSim::m_EventCnt
protected

Event counter.

Definition at line 325 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 325 of file PHG4TrackFastSim.h

Referenced by GetNodes(), InitRun(), and process_event().

std::string PHG4TrackFastSim::m_FitAlgoName
protected

Available choices: KalmanFitter KalmanFitterRefTrack DafSimple DafRef

Definition at line 318 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 318 of file PHG4TrackFastSim.h

Referenced by get_fit_alg_name(), GetNodes(), InitRun(), and set_fit_alg_name().

PHGenFit::Fitter* PHG4TrackFastSim::m_Fitter
protected

GenFit fitter interface

Definition at line 285 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 285 of file PHG4TrackFastSim.h

Referenced by DisplayEvent(), End(), InitRun(), process_event(), and ~PHG4TrackFastSim().

PHParameters* PHG4TrackFastSim::m_Parameter = nullptr
protected

Definition at line 345 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 345 of file PHG4TrackFastSim.h

Referenced by GetNodes(), and PHG4TrackFastSim().

std::vector<float> PHG4TrackFastSim::m_phg4_detector_hitfindeff
protected

Definition at line 300 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 300 of file PHG4TrackFastSim.h

Referenced by add_phg4hits(), GetNodes(), and PseudoPatternRecognition().

std::vector<float> PHG4TrackFastSim::m_phg4_detector_lonres
protected

Definition at line 299 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 299 of file PHG4TrackFastSim.h

Referenced by add_phg4hits(), GetNodes(), and PseudoPatternRecognition().

std::vector<float> PHG4TrackFastSim::m_phg4_detector_noise
protected

Definition at line 301 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 301 of file PHG4TrackFastSim.h

Referenced by add_phg4hits(), GetNodes(), and PseudoPatternRecognition().

std::vector<float> PHG4TrackFastSim::m_phg4_detector_phires
protected

Definition at line 298 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 298 of file PHG4TrackFastSim.h

Referenced by add_phg4hits(), GetNodes(), and PseudoPatternRecognition().

std::vector<float> PHG4TrackFastSim::m_phg4_detector_radres
protected

Definition at line 297 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 297 of file PHG4TrackFastSim.h

Referenced by add_phg4hits(), GetNodes(), and PseudoPatternRecognition().

std::vector<DETECTOR_TYPE> PHG4TrackFastSim::m_phg4_detector_type
protected

Definition at line 296 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 296 of file PHG4TrackFastSim.h

Referenced by add_phg4hits(), GetNodes(), and PseudoPatternRecognition().

std::vector<PHG4HitContainer*> PHG4TrackFastSim::m_PHG4HitContainer
protected

Definition at line 294 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 294 of file PHG4TrackFastSim.h

Referenced by GetNodes(), and PseudoPatternRecognition().

std::vector<std::string> PHG4TrackFastSim::m_PHG4HitsNames
protected

Definition at line 295 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 295 of file PHG4TrackFastSim.h

Referenced by add_phg4hits(), get_phg4hits_names(), GetNodes(), and PseudoPatternRecognition().

int PHG4TrackFastSim::m_PrimaryAssumptionPid
protected

Definition at line 327 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 327 of file PHG4TrackFastSim.h

Referenced by get_primary_assumption_pid(), process_event(), and set_primary_assumption_pid().

int PHG4TrackFastSim::m_PrimaryTrackingFlag
protected

Definition at line 341 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 341 of file PHG4TrackFastSim.h

Referenced by process_event(), and set_primary_tracking().

std::map<std::string, std::pair<int, double> > PHG4TrackFastSim::m_ProjectionsMap
protected

Definition at line 304 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 304 of file PHG4TrackFastSim.h

Referenced by add_cylinder_state(), add_state_name(), add_zplane_state(), InitRun(), and MakeSvtxTrack().

gsl_rng* PHG4TrackFastSim::m_RandomGenerator
protected

random generator that conform with sPHENIX standard

Definition at line 280 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 280 of file PHG4TrackFastSim.h

Referenced by PHG4HitToMeasurementCylinder(), PHG4HitToMeasurementVerticalPlane(), PHG4TrackFastSim(), process_event(), PseudoPatternRecognition(), and ~PHG4TrackFastSim().

genfit::GFRaveVertexFactory* PHG4TrackFastSim::m_RaveVertexFactory
protected

Definition at line 286 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 286 of file PHG4TrackFastSim.h

Referenced by InitRun(), process_event(), and ~PHG4TrackFastSim().

bool PHG4TrackFastSim::m_SmearingFlag
protected

Definition at line 329 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 329 of file PHG4TrackFastSim.h

Referenced by PHG4HitToMeasurementCylinder(), PHG4HitToMeasurementVerticalPlane(), and Smearing().

std::string PHG4TrackFastSim::m_SubTopnodeName
protected

Definition at line 306 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 306 of file PHG4TrackFastSim.h

Referenced by CreateNodes(), get_sub_top_node_name(), GetNodes(), and set_sub_top_node_name().

SvtxTrackMap* PHG4TrackFastSim::m_SvtxTrackMapOut
protected

Definition at line 291 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 291 of file PHG4TrackFastSim.h

Referenced by CreateNodes(), GetNodes(), and process_event().

SvtxVertexMap* PHG4TrackFastSim::m_SvtxVertexMap
protected

Definition at line 292 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 292 of file PHG4TrackFastSim.h

Referenced by CreateNodes(), FillSvtxVertexMap(), and process_event().

std::string PHG4TrackFastSim::m_TrackmapOutNodeName
protected

Definition at line 307 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 307 of file PHG4TrackFastSim.h

Referenced by CreateNodes(), get_trackmap_out_name(), GetNodes(), and set_trackmap_out_name().

PHG4TruthInfoContainer* PHG4TrackFastSim::m_TruthContainer
protected

Input Node pointers.

Definition at line 289 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 289 of file PHG4TrackFastSim.h

Referenced by GetNodes(), and process_event().

bool PHG4TrackFastSim::m_UseVertexInFittingFlag
protected

For PseudoPatternRecognition function.

Definition at line 338 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 338 of file PHG4TrackFastSim.h

Referenced by is_use_vertex_in_fitting(), process_event(), and set_use_vertex_in_fitting().

std::string PHG4TrackFastSim::m_VertexingMethod
protected

https://rave.hepforge.org/trac/wiki/RaveMethods

Definition at line 309 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 309 of file PHG4TrackFastSim.h

Referenced by get_vertexing_method(), GetNodes(), InitRun(), and set_vertexing_method().

double PHG4TrackFastSim::m_VertexMinNdf
protected

Definition at line 320 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 320 of file PHG4TrackFastSim.h

Referenced by get_vertex_min_ndf(), process_event(), and set_vertex_min_ndf().

double PHG4TrackFastSim::m_VertexXYResolution
protected

Definition at line 321 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 321 of file PHG4TrackFastSim.h

Referenced by get_vertex_xy_resolution(), process_event(), and set_vertex_xy_resolution().

double PHG4TrackFastSim::m_VertexZResolution
protected

Definition at line 322 of file PHG4TrackFastSim.h.

View newest version in sPHENIX GitHub at line 322 of file PHG4TrackFastSim.h

Referenced by get_vertex_z_resolution(), process_event(), and set_vertex_z_resolution().


The documentation for this class was generated from the following files: