CMS 3D CMS Logo

List of all members | Public Member Functions | Private Member Functions | Private Attributes
RPCSimAsymmetricCls Class Reference

#include <RPCSimAsymmetricCls.h>

Inheritance diagram for RPCSimAsymmetricCls:
RPCSim

Public Member Functions

int getClSize (float posX, CLHEP::HepRandomEngine *)
 
int getClSize (uint32_t id, float posX, CLHEP::HepRandomEngine *)
 
 RPCSimAsymmetricCls (const edm::ParameterSet &config)
 
void simulate (const RPCRoll *roll, const edm::PSimHitContainer &rpcHits, CLHEP::HepRandomEngine *) override
 
void simulateNoise (const RPCRoll *, CLHEP::HepRandomEngine *) override
 
unsigned int slice (float posX)
 
 ~RPCSimAsymmetricCls () override
 
- Public Member Functions inherited from RPCSim
const DigiSimLinksdigiSimLinks () const
 
virtual void fillDigis (int rollDetId, RPCDigiCollection &digis)
 
RPCSimSetUpgetRPCSimSetUp ()
 
const RPCDigiSimLinksrpcDigiSimLinks () const
 
void setRPCSimSetUp (RPCSimSetUp *setup)
 
virtual ~RPCSim ()
 

Private Member Functions

void init () override
 

Private Attributes

RPCSynchronizer_rpcSync
 
double aveCls
 
double aveEff
 
std::vector< double > clsForDetId
 
std::map< int, std::vector< double > > clsMap
 
double dtimCs
 
bool eledig
 
double frate
 
double gate
 
std::ifstream * infile
 
double lbGate
 
int N_hits
 
int nbxing
 
double rate
 
double resEle
 
double resRPC
 
bool rpcdigiprint
 
double sspeed
 
std::vector< double > sum_clsize
 
double timOff
 

Additional Inherited Members

- Public Types inherited from RPCSim
typedef edm::DetSet< StripDigiSimLinkDigiSimLinks
 
typedef edm::DetSet< RPCDigiSimLinkRPCDigiSimLinks
 
- Protected Types inherited from RPCSim
typedef std::multimap< std::pair< unsigned int, int >, const PSimHit *, std::less< std::pair< unsigned int, int > > > DetectorHitMap
 
- Protected Member Functions inherited from RPCSim
virtual void addLinks (unsigned int strip, int bx)
 
 RPCSim (const edm::ParameterSet &config)
 
- Protected Attributes inherited from RPCSim
std::set< RPCDigiirpc_digis
 
std::set< std::pair< int, int > > strips
 
DetectorHitMap theDetectorHitMap
 
DigiSimLinks theDigiSimLinks
 
RPCDigiSimLinks theRpcDigiSimLinks
 
RPCSimSetUptheSimSetUp
 

Detailed Description

Definition at line 30 of file RPCSimAsymmetricCls.h.

Constructor & Destructor Documentation

◆ RPCSimAsymmetricCls()

RPCSimAsymmetricCls::RPCSimAsymmetricCls ( const edm::ParameterSet config)

Definition at line 40 of file RPCSimAsymmetricCls.cc.

40  : RPCSim(config) {
41  aveEff = config.getParameter<double>("averageEfficiency");
42  aveCls = config.getParameter<double>("averageClusterSize");
43  resRPC = config.getParameter<double>("timeResolution");
44  timOff = config.getParameter<double>("timingRPCOffset");
45  dtimCs = config.getParameter<double>("deltatimeAdjacentStrip");
46  resEle = config.getParameter<double>("timeJitter");
47  sspeed = config.getParameter<double>("signalPropagationSpeed");
48  lbGate = config.getParameter<double>("linkGateWidth");
49  rpcdigiprint = config.getParameter<bool>("printOutDigitizer");
50  eledig = config.getParameter<bool>("digitizeElectrons");
51 
52  rate = config.getParameter<double>("Rate");
53  nbxing = config.getParameter<int>("Nbxing");
54  gate = config.getParameter<double>("Gate");
55  frate = config.getParameter<double>("Frate");
56 
57  if (rpcdigiprint) {
58  std::cout << "Average Efficiency = " << aveEff << std::endl;
59  std::cout << "Average Cluster Size = " << aveCls << " strips" << std::endl;
60  std::cout << "RPC Time Resolution = " << resRPC << " ns" << std::endl;
61  std::cout << "RPC Signal formation time = " << timOff << " ns" << std::endl;
62  std::cout << "RPC adjacent strip delay = " << dtimCs << " ns" << std::endl;
63  std::cout << "Electronic Jitter = " << resEle << " ns" << std::endl;
64  std::cout << "Signal propagation time = " << sspeed << " x c" << std::endl;
65  std::cout << "Link Board Gate Width = " << lbGate << " ns" << std::endl;
66  }
67 
69 }

References _rpcSync, aveCls, aveEff, gather_cfg::cout, dtimCs, eledig, frate, gate, lbGate, nbxing, rate, resEle, resRPC, rpcdigiprint, sspeed, and timOff.

◆ ~RPCSimAsymmetricCls()

RPCSimAsymmetricCls::~RPCSimAsymmetricCls ( )
override

Definition at line 71 of file RPCSimAsymmetricCls.cc.

71 { delete _rpcSync; }

References _rpcSync.

Member Function Documentation

◆ getClSize() [1/2]

int RPCSimAsymmetricCls::getClSize ( float  posX,
CLHEP::HepRandomEngine *  engine 
)

Definition at line 92 of file RPCSimAsymmetricCls.cc.

92  {
93  std::map<int, std::vector<double> > clsMap = getRPCSimSetUp()->getClsMap();
94 
95  int cnt = 1;
96  int min = 1;
97  double func = 0.0;
98  std::vector<double> sum_clsize;
99 
100  double rr_cl = CLHEP::RandFlat::shoot(engine);
101  LogDebug("RPCSimAsymmetricCls") << "[RPCSimAsymmetricCls::getClSize] Fired RandFlat :: " << rr_cl;
102 
103  if (0.0 <= posX && posX < 0.2) {
104  func = (clsMap[1])[(clsMap[1]).size() - 1] * (rr_cl);
105  sum_clsize = clsMap[1];
106  }
107  if (0.2 <= posX && posX < 0.4) {
108  func = (clsMap[2])[(clsMap[2]).size() - 1] * (rr_cl);
109  sum_clsize = clsMap[2];
110  }
111  if (0.4 <= posX && posX < 0.6) {
112  func = (clsMap[3])[(clsMap[3]).size() - 1] * (rr_cl);
113  sum_clsize = clsMap[3];
114  }
115  if (0.6 <= posX && posX < 0.8) {
116  func = (clsMap[4])[(clsMap[4]).size() - 1] * (rr_cl);
117  sum_clsize = clsMap[4];
118  }
119  if (0.8 <= posX && posX < 1.0) {
120  func = (clsMap[5])[(clsMap[5]).size() - 1] * (rr_cl);
121  sum_clsize = clsMap[5];
122  }
123 
124  for (vector<double>::iterator iter = sum_clsize.begin(); iter != sum_clsize.end(); ++iter) {
125  cnt++;
126  if (func > (*iter)) {
127  min = cnt;
128  } else if (func < (*iter)) {
129  break;
130  }
131  }
132  return min;
133 }

References clsMap, TrackCollections2monitor_cff::func, RPCSimSetUp::getClsMap(), RPCSim::getRPCSimSetUp(), LogDebug, min(), RecoTauValidation_cfi::posX, and sum_clsize.

Referenced by simulate().

◆ getClSize() [2/2]

int RPCSimAsymmetricCls::getClSize ( uint32_t  id,
float  posX,
CLHEP::HepRandomEngine *  engine 
)

Definition at line 73 of file RPCSimAsymmetricCls.cc.

73  {
74  std::vector<double> clsForDetId = getRPCSimSetUp()->getAsymmetricClsDistribution(id, slice(posX));
75 
76  int cnt = 1;
77  int min = 1;
78 
79  double rr_cl = CLHEP::RandFlat::shoot(engine);
80  LogDebug("RPCSimAsymmetricCls") << "[RPCSimAsymmetricCls::getClSize] Fired RandFlat :: " << rr_cl;
81  for (unsigned int i = 0; i < clsForDetId.size(); i++) {
82  cnt++;
83  if (rr_cl > clsForDetId[i]) {
84  min = cnt;
85  } else if (rr_cl < clsForDetId[i]) {
86  break;
87  }
88  }
89  return min;
90 }

References clsForDetId, RPCSimSetUp::getAsymmetricClsDistribution(), RPCSim::getRPCSimSetUp(), mps_fire::i, LogDebug, min(), RecoTauValidation_cfi::posX, and slice().

◆ init()

void RPCSimAsymmetricCls::init ( void  )
inlineoverrideprivatevirtual

Implements RPCSim.

Definition at line 44 of file RPCSimAsymmetricCls.h.

44 {};

◆ simulate()

void RPCSimAsymmetricCls::simulate ( const RPCRoll roll,
const edm::PSimHitContainer rpcHits,
CLHEP::HepRandomEngine *  engine 
)
overridevirtual

Implements RPCSim.

Definition at line 135 of file RPCSimAsymmetricCls.cc.

137  {
140  theDetectorHitMap.clear();
142 
143  RPCDetId rpcId = roll->id();
144  RPCGeomServ RPCname(rpcId);
145  std::string nameRoll = RPCname.name();
146 
147  const Topology& topology = roll->specs()->topology();
148  for (edm::PSimHitContainer::const_iterator _hit = rpcHits.begin(); _hit != rpcHits.end(); ++_hit) {
149  if (!eledig && _hit->particleType() == 11)
150  continue;
151  // Here I hould check if the RPC are up side down;
152  const LocalPoint& entr = _hit->entryPoint();
153 
154  int time_hit = _rpcSync->getSimHitBx(&(*_hit), engine);
155  float posX = roll->strip(_hit->localPosition()) - static_cast<int>(roll->strip(_hit->localPosition()));
156 
157  std::vector<float> veff = (getRPCSimSetUp())->getEff(rpcId.rawId());
158 
159  std::stringstream veffstream;
160  veffstream << "[";
161  for (std::vector<float>::iterator veffIt = veff.begin(); veffIt != veff.end(); ++veffIt) {
162  veffstream << (*veffIt) << ",";
163  }
164  veffstream << "]";
165  std::string veffstr = veffstream.str();
166  LogDebug("RPCSimAsymmetricCls") << "Get Eff from RPCSimSetup for detId = " << rpcId.rawId() << " :: " << veffstr;
167 
168  // Efficiency
169  int centralStrip = topology.channel(entr) + 1;
170  float fire = CLHEP::RandFlat::shoot(engine);
171  LogDebug("RPCSimAsymmetricCls") << "[RPCSimAsymmetricCls::simulate] Fired RandFlat :: " << fire << " --> < "
172  << veff[centralStrip - 1] << " ? --> " << ((fire < veff[centralStrip - 1]) ? 1 : 0);
173 
174  if (fire < veff[centralStrip - 1]) {
175  LogDebug("RPCSimAsymmetricCls") << "Detector is Efficient for this simhit";
176 
177  int fstrip = centralStrip;
178  int lstrip = centralStrip;
179 
180  // Compute the cluster size
181 
182  //double w = CLHEP::RandFlat::shoot(engine);
183  //LogDebug ("RPCSimAsymmetricCls")<<"[RPCSimAsymmetricCls::simulate] Fired RandFlat :: "<<w<<" (w is not used)";
184  //if (w < 1.e-10) w=1.e-10;
185 
186  int clsize = this->getClSize(rpcId.rawId(), posX, engine); // This is for cluster size chamber by chamber
187  LogDebug("RPCSimAsymmetricCls") << "Clustersize = " << clsize;
188 
189  std::vector<int> cls;
190 
191  cls.push_back(centralStrip);
192  if (clsize > 1) {
193  for (int cl = 0; cl < (clsize - 1) / 2; cl++) {
194  if (centralStrip - cl - 1 >= 1) {
195  fstrip = centralStrip - cl - 1;
196  cls.push_back(fstrip);
197  }
198  if (centralStrip + cl + 1 <= roll->nstrips()) {
199  lstrip = centralStrip + cl + 1;
200  cls.push_back(lstrip);
201  }
202  }
203  if (clsize % 2 == 0) { //even cluster size is a special case
204  if (clsize > 5) {
205  // insert the last strip according to the
206  // simhit position in the central strip
207  // needed for cls > 5, because higher cluster size has no asymmetry
208  // and thus is treated like in the old parametrization
209  double deltaw = roll->centreOfStrip(centralStrip).x() - entr.x();
210  if (deltaw < 0.) {
211  if (lstrip < roll->nstrips()) {
212  lstrip++;
213  cls.push_back(lstrip);
214  }
215  } else {
216  if (fstrip > 1) {
217  fstrip--;
218  cls.push_back(fstrip);
219  }
220  }
221  } else {
222  // needed for correct initial position for even cluster size
223  // in case of asymmetric cluster size
224  if (lstrip < roll->nstrips()) {
225  lstrip++;
226  cls.push_back(lstrip);
227  }
228  }
229  }
230  }
231 
232  //Now calculate the shift according to the distribution
233  float fire1 = CLHEP::RandFlat::shoot(engine);
234  LogDebug("RPCSimAsymmetricCls") << "[RPCSimAsymmetricCls::simulate] Fired RandFlat :: " << fire1
235  << " (fire1 is used for a shift of the cluster)";
236 
237  int strip_shift = 0;
238 
239  int offset;
240 
241  if (clsize % 2 == 0) {
242  offset = 2;
243  } else {
244  offset = 1;
245  }
246 
247  //No shift (asymmetry) for higher cluster size.
248  if (clsize > 5) {
249  strip_shift = 0;
250  } else {
251  std::vector<double> TMPclsAsymmForDetId = getRPCSimSetUp()->getAsymmetryForCls(rpcId, slice(posX), clsize);
252 
253  for (unsigned int i = 0; i < TMPclsAsymmForDetId.size(); i++) {
254  if (fire1 < TMPclsAsymmForDetId[i]) {
255  strip_shift = i - offset;
256  break;
257  }
258  }
259  }
260 
261  vector<int> shifted_cls; // vector to hold shifted strips
262  shifted_cls.clear();
263 
264  int min_strip = 100;
265  int max_strip = 0;
266 
267  //correction for the edges
268  for (std::vector<int>::iterator i = cls.begin(); i != cls.end(); i++) {
269  if (*i + strip_shift < min_strip) {
270  min_strip = *i + strip_shift;
271  }
272  if (*i + strip_shift > max_strip) {
273  max_strip = *i + strip_shift;
274  }
275  }
276 
277  if (min_strip < 1 || max_strip - roll->nstrips() > 0) {
278  strip_shift = 0;
279  }
280 
281  //Now shift the cluster
282  for (std::vector<int>::iterator i = cls.begin(); i != cls.end(); i++) {
283  shifted_cls.push_back(*i + strip_shift);
284  }
285  for (std::vector<int>::iterator i = shifted_cls.begin(); i != shifted_cls.end(); i++) {
286  // Check the timing of the adjacent strip
287  if (*i != centralStrip) {
288  double fire2 = CLHEP::RandFlat::shoot(engine);
289  LogDebug("RPCSimAsymmetricCls") << "[RPCSimAsymmetricCls::simulate] Fired RandFlat :: " << fire2
290  << " (check whether adjacent strips are efficient)";
291  if (fire2 < veff[*i - 1]) {
292  std::pair<int, int> digi(*i, time_hit);
293  strips.insert(digi);
294  LogDebug("RPCSimAsymmetricCls")
295  << "RPC Digi inserted :: Signl :: DetId :: " << rpcId << " = " << rpcId.rawId() << " ==> digi <"
296  << digi.first << "," << digi.second << ">";
297 
298  theDetectorHitMap.insert(DetectorHitMap::value_type(digi, &(*_hit)));
299  }
300  } else {
301  std::pair<int, int> digi(*i, time_hit);
302  theDetectorHitMap.insert(DetectorHitMap::value_type(digi, &(*_hit)));
303 
304  strips.insert(digi);
305  LogDebug("RPCSimAsymmetricCls") << "RPC Digi inserted :: Signl :: DetId :: " << rpcId << " = "
306  << rpcId.rawId() << " ==> digi <" << digi.first << "," << digi.second << ">";
307  }
308  }
309  }
310  }
311 }

References _rpcSync, RPCRoll::centreOfStrip(), GetRecoTauVFromDQM_MC_cff::cl, edm::DetSet< T >::clear(), eledig, RPCSimSetUp::getAsymmetryForCls(), getClSize(), RPCSim::getRPCSimSetUp(), RPCSynchronizer::getSimHitBx(), mps_fire::i, RPCRoll::id(), LogDebug, RPCGeomServ::name(), RPCRoll::nstrips(), hltrates_dqm_sourceclient-live_cfg::offset, RecoTauValidation_cfi::posX, DetId::rawId(), RPCSynchronizer::setRPCSimSetUp(), slice(), RPCRoll::specs(), AlCaHLTBitMon_QueryRunRegistry::string, RPCRoll::strip(), RPCSim::strips, RPCSim::theDetectorHitMap, RPCSim::theRpcDigiSimLinks, RPCRollSpecs::topology(), ecaldqm::topology(), and PV3DBase< T, PVType, FrameType >::x().

◆ simulateNoise()

void RPCSimAsymmetricCls::simulateNoise ( const RPCRoll roll,
CLHEP::HepRandomEngine *  engine 
)
overridevirtual

Implements RPCSim.

Definition at line 313 of file RPCSimAsymmetricCls.cc.

313  {
314  RPCDetId rpcId = roll->id();
315 
316  RPCGeomServ RPCname(rpcId);
317  std::string nameRoll = RPCname.name();
318 
319  std::vector<float> vnoise = (getRPCSimSetUp())->getNoise(rpcId.rawId());
320  std::vector<float> veff = (getRPCSimSetUp())->getEff(rpcId.rawId());
321 
322  LogDebug("RPCSimAsymmetricCls") << "[RPCSimAsymmetricCls::simulateNoise] Treating DetId :: " << rpcId << " = "
323  << rpcId.rawId() << " which has " << roll->nstrips() << " strips";
324 
325  std::stringstream vnoisestream;
326  vnoisestream << "[";
327  for (std::vector<float>::iterator vnoiseIt = vnoise.begin(); vnoiseIt != vnoise.end(); ++vnoiseIt) {
328  vnoisestream << (*vnoiseIt) << ",";
329  }
330  vnoisestream << "]";
331  std::string vnoisestr = vnoisestream.str();
332  LogDebug("RPCSimAsymmetricCls") << "Get Noise from RPCSimSetup for detId = " << rpcId.rawId() << " :: vector with "
333  << vnoise.size() << "entries :: " << vnoisestr;
334 
335  unsigned int nstrips = roll->nstrips();
336  double area = 0.0;
337 
338  if (rpcId.region() == 0) {
339  const RectangularStripTopology* top_ = dynamic_cast<const RectangularStripTopology*>(&(roll->topology()));
340  float xmin = (top_->localPosition(0.)).x();
341  float xmax = (top_->localPosition((float)roll->nstrips())).x();
342  float striplength = (top_->stripLength());
343  area = striplength * (xmax - xmin);
344  } else {
345  const TrapezoidalStripTopology* top_ = dynamic_cast<const TrapezoidalStripTopology*>(&(roll->topology()));
346  float xmin = (top_->localPosition(0.)).x();
347  float xmax = (top_->localPosition((float)roll->nstrips())).x();
348  float striplength = (top_->stripLength());
349  area = striplength * (xmax - xmin);
350  }
351 
352  LogDebug("RPCSimAsymmetricCls") << "Noise :: vnoise.size() = " << vnoise.size();
353 
354  for (unsigned int j = 0; j < vnoise.size(); ++j) {
355  if (j >= nstrips)
356  break;
357 
358  // The efficiency of 0% does not imply on the noise rate.
359  // If the strip is masked the noise rate should be 0 Hz/cm^2
360  // if(veff[j] == 0) continue;
361 
362  // double ave = vnoise[j]*nbxing*gate*area*1.0e-9*frate;
363  // The vnoise is the noise rate per strip, so we shout multiply not
364  // by the chamber area,
365  // but the strip area which is area/((float)roll->nstrips()));
366  double ave = vnoise[j] * nbxing * gate * area * 1.0e-9 * frate / ((float)roll->nstrips());
367  LogDebug("RPCSimAsymmetricCls") << "Noise :: strip " << j << " Average = " << ave
368  << " = vnoise[j]*nbxing*gate*area*1.0e-9*frate/((float)roll->nstrips()) = "
369  << vnoise[j] << "*" << nbxing << "*" << gate << "*" << area << "*" << 1.0e-9 << "*"
370  << frate << "/" << ((float)roll->nstrips());
371 
372  CLHEP::RandPoissonQ randPoissonQ(*engine, ave);
373  N_hits = randPoissonQ.fire();
374  LogDebug("RPCSimAsymmetricCls") << "[RPCSimAsymmetricCls::simulateNoise] Fired RandPoissonQ :: " << N_hits;
375  LogDebug("RPCSimAsymmetricCls") << "Noise :: Amount of Noise Hits for DetId :: " << rpcId << " = " << rpcId.rawId()
376  << " = N_hits = randPoissonQ.fire() = " << N_hits;
377 
378  for (int i = 0; i < N_hits; i++) {
379  double time2 = CLHEP::RandFlat::shoot((nbxing * gate) / gate);
380  LogDebug("RPCSimAsymmetricCls") << "[RPCSimAsymmetricCls::simulateNoise] Fired RandFlat :: " << time2;
381  int time_hit = (static_cast<int>(time2) - nbxing / 2);
382  std::pair<int, int> digi(j + 1, time_hit);
383  strips.insert(digi);
384  LogDebug("RPCSimAsymmetricCls") << "RPC Digi inserted :: Noise :: DetId :: " << rpcId << " = " << rpcId.rawId()
385  << " ==> digi <" << digi.first << "," << digi.second << ">";
386  }
387  }
388 }

References custom_jme_cff::area, dqmMemoryStats::float, frate, gate, RPCSim::getRPCSimSetUp(), mps_fire::i, RPCRoll::id(), dqmiolumiharvest::j, RectangularStripTopology::localPosition(), TrapezoidalStripTopology::localPosition(), LogDebug, N_hits, RPCGeomServ::name(), nbxing, RPCRoll::nstrips(), DetId::rawId(), RPCDetId::region(), AlCaHLTBitMon_QueryRunRegistry::string, RectangularStripTopology::stripLength(), TrapezoidalStripTopology::stripLength(), RPCSim::strips, RPCRoll::topology(), x, TrackerOfflineValidation_Dqm_cff::xmax, and TrackerOfflineValidation_Dqm_cff::xmin.

◆ slice()

unsigned int RPCSimAsymmetricCls::slice ( float  posX)

Definition at line 390 of file RPCSimAsymmetricCls.cc.

390  {
391  if (0.0 <= posX && posX < 0.2) {
392  return 0;
393  } else if (0.2 <= posX && posX < 0.4) {
394  return 1;
395  } else if (0.4 <= posX && posX < 0.6) {
396  return 2;
397  } else if (0.6 <= posX && posX < 0.8) {
398  return 3;
399  } else if (0.8 <= posX && posX < 1.0) {
400  return 4;
401  } else
402  return 2;
403 }

References RecoTauValidation_cfi::posX.

Referenced by getClSize(), and simulate().

Member Data Documentation

◆ _rpcSync

RPCSynchronizer* RPCSimAsymmetricCls::_rpcSync
private

Definition at line 69 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls(), simulate(), and ~RPCSimAsymmetricCls().

◆ aveCls

double RPCSimAsymmetricCls::aveCls
private

Definition at line 48 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ aveEff

double RPCSimAsymmetricCls::aveEff
private

Definition at line 44 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ clsForDetId

std::vector<double> RPCSimAsymmetricCls::clsForDetId
private

Definition at line 66 of file RPCSimAsymmetricCls.h.

Referenced by getClSize().

◆ clsMap

std::map<int, std::vector<double> > RPCSimAsymmetricCls::clsMap
private

Definition at line 64 of file RPCSimAsymmetricCls.h.

Referenced by getClSize().

◆ dtimCs

double RPCSimAsymmetricCls::dtimCs
private

Definition at line 51 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ eledig

bool RPCSimAsymmetricCls::eledig
private

Definition at line 56 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls(), and simulate().

◆ frate

double RPCSimAsymmetricCls::frate
private

Definition at line 62 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls(), and simulateNoise().

◆ gate

double RPCSimAsymmetricCls::gate
private

Definition at line 61 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls(), and simulateNoise().

◆ infile

std::ifstream* RPCSimAsymmetricCls::infile
private

Definition at line 67 of file RPCSimAsymmetricCls.h.

◆ lbGate

double RPCSimAsymmetricCls::lbGate
private

Definition at line 54 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ N_hits

int RPCSimAsymmetricCls::N_hits
private

Definition at line 58 of file RPCSimAsymmetricCls.h.

Referenced by simulateNoise().

◆ nbxing

int RPCSimAsymmetricCls::nbxing
private

Definition at line 59 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls(), and simulateNoise().

◆ rate

double RPCSimAsymmetricCls::rate
private

Definition at line 60 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ resEle

double RPCSimAsymmetricCls::resEle
private

Definition at line 52 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ resRPC

double RPCSimAsymmetricCls::resRPC
private

Definition at line 49 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ rpcdigiprint

bool RPCSimAsymmetricCls::rpcdigiprint
private

Definition at line 55 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ sspeed

double RPCSimAsymmetricCls::sspeed
private

Definition at line 53 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

◆ sum_clsize

std::vector<double> RPCSimAsymmetricCls::sum_clsize
private

Definition at line 65 of file RPCSimAsymmetricCls.h.

Referenced by getClSize().

◆ timOff

double RPCSimAsymmetricCls::timOff
private

Definition at line 50 of file RPCSimAsymmetricCls.h.

Referenced by RPCSimAsymmetricCls().

RPCSynchronizer::setRPCSimSetUp
void setRPCSimSetUp(RPCSimSetUp *simsetup)
Definition: RPCSynchronizer.h:43
RPCSim::getRPCSimSetUp
RPCSimSetUp * getRPCSimSetUp()
Definition: RPCSim.h:45
RPCSimAsymmetricCls::getClSize
int getClSize(float posX, CLHEP::HepRandomEngine *)
Definition: RPCSimAsymmetricCls.cc:92
mps_fire.i
i
Definition: mps_fire.py:428
TrapezoidalStripTopology::stripLength
float stripLength() const override
det heigth (strip length in the middle)
Definition: TrapezoidalStripTopology.h:63
RPCSimAsymmetricCls::slice
unsigned int slice(float posX)
Definition: RPCSimAsymmetricCls.cc:390
RPCGeomServ
Definition: RPCGeomServ.h:8
RPCSimAsymmetricCls::nbxing
int nbxing
Definition: RPCSimAsymmetricCls.h:59
RPCSimAsymmetricCls::timOff
double timOff
Definition: RPCSimAsymmetricCls.h:50
dqmMemoryStats.float
float
Definition: dqmMemoryStats.py:127
RPCSimSetUp::getAsymmetricClsDistribution
const std::vector< double > & getAsymmetricClsDistribution(uint32_t id, uint32_t slice)
Definition: RPCSimSetUp.cc:438
RPCDetId::region
int region() const
Region id: 0 for Barrel, +/-1 For +/- Endcap.
Definition: RPCDetId.h:53
PV3DBase::x
T x() const
Definition: PV3DBase.h:59
min
T min(T a, T b)
Definition: MathUtil.h:58
edm::DetSet::clear
void clear()
Definition: DetSet.h:71
RPCSim::RPCSim
RPCSim(const edm::ParameterSet &config)
Definition: RPCSim.cc:5
RPCDetId
Definition: RPCDetId.h:16
gather_cfg.cout
cout
Definition: gather_cfg.py:144
RPCSynchronizer
Definition: RPCSynchronizer.h:36
RPCSynchronizer::getSimHitBx
int getSimHitBx(const PSimHit *, CLHEP::HepRandomEngine *)
Definition: RPCSynchronizer.cc:57
DDAxes::x
RPCSim::strips
std::set< std::pair< int, int > > strips
Definition: RPCSim.h:55
RPCSimAsymmetricCls::frate
double frate
Definition: RPCSimAsymmetricCls.h:62
RPCSimAsymmetricCls::rate
double rate
Definition: RPCSimAsymmetricCls.h:60
RPCSimAsymmetricCls::aveCls
double aveCls
Definition: RPCSimAsymmetricCls.h:48
RectangularStripTopology::localPosition
LocalPoint localPosition(float strip) const override
Definition: RectangularStripTopology.cc:17
RPCRoll::topology
const Topology & topology() const override
Definition: RPCRoll.cc:18
GetRecoTauVFromDQM_MC_cff.cl
cl
Definition: GetRecoTauVFromDQM_MC_cff.py:38
config
Definition: config.py:1
RPCRoll::id
RPCDetId id() const
Definition: RPCRoll.cc:16
RectangularStripTopology
Definition: RectangularStripTopology.h:11
RPCSim::theDetectorHitMap
DetectorHitMap theDetectorHitMap
Definition: RPCSim.h:68
ecaldqm::topology
const CaloTopology * topology(nullptr)
TrapezoidalStripTopology
Definition: TrapezoidalStripTopology.h:21
RPCSim::theRpcDigiSimLinks
RPCDigiSimLinks theRpcDigiSimLinks
Definition: RPCSim.h:70
RPCRollSpecs::topology
const Topology & topology() const override
Definition: RPCRollSpecs.cc:36
RecoTauValidation_cfi.posX
posX
Definition: RecoTauValidation_cfi.py:288
RPCSimAsymmetricCls::_rpcSync
RPCSynchronizer * _rpcSync
Definition: RPCSimAsymmetricCls.h:69
RPCSimSetUp::getClsMap
const std::map< int, std::vector< double > > & getClsMap()
Definition: RPCSimSetUp.cc:411
Point3DBase< float, LocalTag >
RPCSimSetUp::getAsymmetryForCls
const std::vector< double > & getAsymmetryForCls(uint32_t id, uint32_t slice, uint32_t cls)
Definition: RPCSimSetUp.cc:502
RPCRoll::strip
float strip(const LocalPoint &lp) const
Definition: RPCRoll.cc:35
AlCaHLTBitMon_QueryRunRegistry.string
string
Definition: AlCaHLTBitMon_QueryRunRegistry.py:256
RPCRoll::centreOfStrip
LocalPoint centreOfStrip(int strip) const
Definition: RPCRoll.cc:26
RectangularStripTopology::stripLength
float stripLength() const override
Definition: RectangularStripTopology.h:44
LogDebug
#define LogDebug(id)
Definition: MessageLogger.h:223
RPCSimAsymmetricCls::lbGate
double lbGate
Definition: RPCSimAsymmetricCls.h:54
RPCRoll::nstrips
int nstrips() const
Definition: RPCRoll.cc:24
RPCSimAsymmetricCls::sum_clsize
std::vector< double > sum_clsize
Definition: RPCSimAsymmetricCls.h:65
RPCSimAsymmetricCls::clsForDetId
std::vector< double > clsForDetId
Definition: RPCSimAsymmetricCls.h:66
RPCSimAsymmetricCls::resRPC
double resRPC
Definition: RPCSimAsymmetricCls.h:49
reco::JetExtendedAssociation::value_type
Container::value_type value_type
Definition: JetExtendedAssociation.h:30
RPCSimAsymmetricCls::dtimCs
double dtimCs
Definition: RPCSimAsymmetricCls.h:51
TrackCollections2monitor_cff.func
func
Definition: TrackCollections2monitor_cff.py:359
RPCSimAsymmetricCls::sspeed
double sspeed
Definition: RPCSimAsymmetricCls.h:53
DetId::rawId
constexpr uint32_t rawId() const
get the raw id
Definition: DetId.h:57
RPCSimAsymmetricCls::aveEff
double aveEff
Definition: RPCSimAsymmetricCls.h:44
RPCSimAsymmetricCls::clsMap
std::map< int, std::vector< double > > clsMap
Definition: RPCSimAsymmetricCls.h:64
TrackerOfflineValidation_Dqm_cff.xmax
xmax
Definition: TrackerOfflineValidation_Dqm_cff.py:11
RPCSimAsymmetricCls::rpcdigiprint
bool rpcdigiprint
Definition: RPCSimAsymmetricCls.h:55
RPCRoll::specs
const RPCRollSpecs * specs() const
Definition: RPCRoll.cc:14
TrapezoidalStripTopology::localPosition
LocalPoint localPosition(float strip) const override
Definition: TrapezoidalStripTopology.cc:27
Topology
Definition: Topology.h:39
RPCSimAsymmetricCls::gate
double gate
Definition: RPCSimAsymmetricCls.h:61
TrackerOfflineValidation_Dqm_cff.xmin
xmin
Definition: TrackerOfflineValidation_Dqm_cff.py:10
RPCSimAsymmetricCls::resEle
double resEle
Definition: RPCSimAsymmetricCls.h:52
dqmiolumiharvest.j
j
Definition: dqmiolumiharvest.py:66
RPCSimAsymmetricCls::eledig
bool eledig
Definition: RPCSimAsymmetricCls.h:56
hltrates_dqm_sourceclient-live_cfg.offset
offset
Definition: hltrates_dqm_sourceclient-live_cfg.py:82
RPCSim::RPCDigiSimLinks
edm::DetSet< RPCDigiSimLink > RPCDigiSimLinks
Definition: RPCSim.h:33
RPCSimAsymmetricCls::N_hits
int N_hits
Definition: RPCSimAsymmetricCls.h:58
custom_jme_cff.area
area
Definition: custom_jme_cff.py:140