CMS 3D CMS Logo

List of all members | Public Member Functions | Protected Member Functions | Private Types | Private Member Functions | Private Attributes
DreamSD Class Reference

#include <DreamSD.h>

Inheritance diagram for DreamSD:
CaloSD SensitiveCaloDetector Observer< const BeginOfRun * > Observer< const BeginOfEvent * > Observer< const BeginOfTrack * > Observer< const EndOfTrack * > Observer< const EndOfEvent * > SensitiveDetector

Public Member Functions

 DreamSD (G4String, const DDCompactView &, const SensitiveDetectorCatalog &, edm::ParameterSet const &, const SimTrackManager *)
 
virtual bool ProcessHits (G4Step *step, G4TouchableHistory *tHistory)
 
virtual uint32_t setDetUnitId (G4Step *)
 
virtual ~DreamSD ()
 
- Public Member Functions inherited from CaloSD
 CaloSD (G4String aSDname, const DDCompactView &cpv, const SensitiveDetectorCatalog &clg, edm::ParameterSet const &p, const SimTrackManager *, float timeSlice=1., bool ignoreTkID=false)
 
virtual void clear ()
 
virtual void DrawAll ()
 
virtual void EndOfEvent (G4HCofThisEvent *eventHC)
 
void fillHits (edm::PCaloHitContainer &, std::string n)
 
virtual double getEnergyDeposit (G4Step *step)
 
virtual void Initialize (G4HCofThisEvent *HCE)
 
virtual void PrintAll ()
 
virtual bool ProcessHits (G4GFlashSpot *aSpot, G4TouchableHistory *)
 
virtual ~CaloSD ()
 
- Public Member Functions inherited from SensitiveCaloDetector
 SensitiveCaloDetector (std::string &iname, const DDCompactView &cpv, const SensitiveDetectorCatalog &clg, edm::ParameterSet const &p)
 
- Public Member Functions inherited from SensitiveDetector
virtual void AssignSD (const std::string &vname)
 
Local3DPoint ConvertToLocal3DPoint (const G4ThreeVector &point)
 
Local3DPoint FinalStepPosition (G4Step *s, coordinates)
 
virtual std::vector< std::string > getNames ()
 
Local3DPoint InitialStepPosition (G4Step *s, coordinates)
 
std::string nameOfSD ()
 
void NaNTrap (G4Step *step)
 
void Register ()
 
 SensitiveDetector (std::string &iname, const DDCompactView &cpv, const SensitiveDetectorCatalog &, edm::ParameterSet const &p)
 
virtual ~SensitiveDetector ()
 
- Public Member Functions inherited from Observer< const BeginOfRun * >
 Observer ()
 
void slotForUpdate (const BeginOfRun * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const BeginOfEvent * >
 Observer ()
 
void slotForUpdate (const BeginOfEvent * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const BeginOfTrack * >
 Observer ()
 
void slotForUpdate (const BeginOfTrack * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const EndOfTrack * >
 Observer ()
 
void slotForUpdate (const EndOfTrack * iT)
 
virtual ~Observer ()
 
- Public Member Functions inherited from Observer< const EndOfEvent * >
 Observer ()
 
void slotForUpdate (const EndOfEvent * iT)
 
virtual ~Observer ()
 

Protected Member Functions

virtual G4bool getStepInfo (G4Step *aStep)
 
virtual void initRun ()
 
- Protected Member Functions inherited from CaloSD
G4bool checkHit ()
 
virtual void clearHits ()
 
CaloG4HitcreateNewHit ()
 
virtual bool filterHit (CaloG4Hit *, double)
 
double getAttenuation (G4Step *aStep, double birk1, double birk2, double birk3)
 
virtual uint16_t getDepth (G4Step *)
 
int getNumberOfHits ()
 
double getResponseWt (G4Track *)
 
virtual int getTrackID (G4Track *)
 
G4bool hitExists ()
 
void resetForNewPrimary (const G4ThreeVector &, double)
 
G4ThreeVector setToGlobal (const G4ThreeVector &, const G4VTouchable *)
 
G4ThreeVector setToLocal (const G4ThreeVector &, const G4VTouchable *)
 
virtual void update (const BeginOfRun *)
 This routine will be called when the appropriate signal arrives. More...
 
virtual void update (const BeginOfEvent *)
 This routine will be called when the appropriate signal arrives. More...
 
virtual void update (const BeginOfTrack *trk)
 This routine will be called when the appropriate signal arrives. More...
 
virtual void update (const EndOfTrack *trk)
 This routine will be called when the appropriate signal arrives. More...
 
virtual void update (const ::EndOfEvent *)
 
void updateHit (CaloG4Hit *)
 
- Protected Member Functions inherited from Observer< const EndOfEvent * >
virtual void update (const EndOfEvent *)=0
 This routine will be called when the appropriate signal arrives. More...
 

Private Types

typedef std::map< G4LogicalVolume *, DoublesDimensionMap
 
typedef std::pair< double, double > Doubles
 

Private Member Functions

double cherenkovDeposit_ (G4Step *aStep)
 Returns the total energy due to Cherenkov radiation. More...
 
const double crystalLength (G4LogicalVolume *) const
 
const double crystalWidth (G4LogicalVolume *) const
 
double curve_LY (G4Step *, int)
 
double getAverageNumberOfPhotons_ (const double charge, const double beta, const G4Material *aMaterial, G4MaterialPropertyVector *rIndex)
 Returns average number of photons created by track. More...
 
double getPhotonEnergyDeposit_ (const G4ParticleMomentum &p, const G4ThreeVector &x, const G4Step *aStep)
 Returns energy deposit for a given photon. More...
 
void initMap (G4String, const DDCompactView &)
 
bool setPbWO2MaterialProperties_ (G4Material *aMaterial)
 Sets material properties at run-time... More...
 

Private Attributes

double birk1
 
double birk2
 
double birk3
 
std::auto_ptr< G4PhysicsOrderedFreeVector > chAngleIntegrals_
 Table of Cherenkov angle integrals vs photon momentum. More...
 
bool doCherenkov_
 
G4MaterialPropertiesTable * materialPropertiesTable
 
int nphotons_
 
TTree * ntuple_
 
float px_ [MAXPHOTONS]
 
float py_ [MAXPHOTONS]
 
float pz_ [MAXPHOTONS]
 
bool readBothSide_
 
int side
 
double slopeLY
 
bool useBirk
 
float x_ [MAXPHOTONS]
 
DimensionMap xtalLMap
 
float y_ [MAXPHOTONS]
 
float z_ [MAXPHOTONS]
 

Additional Inherited Members

- Public Types inherited from SensitiveDetector
enum  coordinates { WorldCoordinates, LocalCoordinates }
 
- Protected Attributes inherited from CaloSD
int checkHits
 
double correctT
 
bool corrTOFBeam
 
CaloG4HitcurrentHit
 
CaloHitID currentID
 
float edepositEM
 
float edepositHAD
 
double eminHit
 
double eminHitD
 
G4int emPDG
 
double energyCut
 
G4ThreeVector entranceLocal
 
G4ThreeVector entrancePoint
 
G4int epPDG
 
bool forceSave
 
G4int gammaPDG
 
float incidentEnergy
 
double kmaxIon
 
double kmaxNeutron
 
double kmaxProton
 
const SimTrackManagerm_trackManager
 
G4ThreeVector posGlobal
 
G4StepPoint * preStepPoint
 
CaloHitID previousID
 
int primIDSaved
 
bool runInit
 
bool suppressHeavy
 
G4Track * theTrack
 
double tmaxHit
 
bool useMap
 

Detailed Description

Definition at line 19 of file DreamSD.h.

Member Typedef Documentation

typedef std::map<G4LogicalVolume*,Doubles> DreamSD::DimensionMap
private

Definition at line 37 of file DreamSD.h.

typedef std::pair<double,double> DreamSD::Doubles
private

Definition at line 36 of file DreamSD.h.

Constructor & Destructor Documentation

DreamSD::DreamSD ( G4String  name,
const DDCompactView cpv,
const SensitiveDetectorCatalog clg,
edm::ParameterSet const &  p,
const SimTrackManager manager 
)

Definition at line 29 of file DreamSD.cc.

References birk1, birk2, birk3, doCherenkov_, g, edm::ParameterSet::getParameter(), edm::ParameterSet::getUntrackedParameter(), initMap(), edm::Service< T >::isAvailable(), TFileService::make(), MeV, nphotons_, ntuple_, px_, py_, pz_, readBothSide_, slopeLY, compare::tfile, useBirk, x_, y_, and z_.

31  :
32  CaloSD(name, cpv, clg, p, manager) {
33 
34  edm::ParameterSet m_EC = p.getParameter<edm::ParameterSet>("ECalSD");
35  useBirk= m_EC.getParameter<bool>("UseBirkLaw");
36  doCherenkov_ = m_EC.getParameter<bool>("doCherenkov");
37  birk1 = m_EC.getParameter<double>("BirkC1")*(g/(MeV*cm2));
38  birk2 = m_EC.getParameter<double>("BirkC2");
39  birk3 = m_EC.getParameter<double>("BirkC3");
40  slopeLY= m_EC.getParameter<double>("SlopeLightYield");
41  readBothSide_ = m_EC.getUntrackedParameter<bool>("ReadBothSide", false);
42 
43  edm::LogInfo("EcalSim") << "Constructing a DreamSD with name " << GetName() << "\n"
44  << "DreamSD:: Use of Birks law is set to "
45  << useBirk << " with three constants kB = "
46  << birk1 << ", C1 = " << birk2 << ", C2 = "
47  << birk3 << "\n"
48  << " Slope for Light yield is set to "
49  << slopeLY << "\n"
50  << " Parameterization of Cherenkov is set to "
51  << doCherenkov_ << " and readout both sides is "
52  << readBothSide_;
53 
54  initMap(name,cpv);
55 
56  // Init histogramming
58 
59  if ( !tfile.isAvailable() )
60  throw cms::Exception("BadConfig") << "TFileService unavailable: "
61  << "please add it to config file";
62 
63  ntuple_ = tfile->make<TTree>("tree","Cherenkov photons");
64  if (doCherenkov_) {
65  ntuple_->Branch("nphotons",&nphotons_,"nphotons/I");
66  ntuple_->Branch("px",px_,"px[nphotons]/F");
67  ntuple_->Branch("py",py_,"py[nphotons]/F");
68  ntuple_->Branch("pz",pz_,"pz[nphotons]/F");
69  ntuple_->Branch("x",x_,"x[nphotons]/F");
70  ntuple_->Branch("y",y_,"y[nphotons]/F");
71  ntuple_->Branch("z",z_,"z[nphotons]/F");
72  }
73 
74 }
T getParameter(std::string const &) const
T getUntrackedParameter(std::string const &, T const &) const
bool readBothSide_
Definition: DreamSD.h:58
float y_[MAXPHOTONS]
Definition: DreamSD.h:72
double birk1
Definition: DreamSD.h:59
T * make(const Args &...args) const
make new ROOT object
Definition: TFileService.h:64
double birk3
Definition: DreamSD.h:59
float px_[MAXPHOTONS]
Definition: DreamSD.h:71
TTree * ntuple_
Definition: DreamSD.h:69
The Signals That Services Can Subscribe To This is based on ActivityRegistry and is current per Services can connect to the signals distributed by the ActivityRegistry in order to monitor the activity of the application Each possible callback has some defined which we here list in angle e g
Definition: Activities.doc:4
CaloSD(G4String aSDname, const DDCompactView &cpv, const SensitiveDetectorCatalog &clg, edm::ParameterSet const &p, const SimTrackManager *, float timeSlice=1., bool ignoreTkID=false)
Definition: CaloSD.cc:24
const double MeV
float z_[MAXPHOTONS]
Definition: DreamSD.h:72
int nphotons_
Definition: DreamSD.h:70
float pz_[MAXPHOTONS]
Definition: DreamSD.h:71
bool isAvailable() const
Definition: Service.h:46
double birk2
Definition: DreamSD.h:59
float x_[MAXPHOTONS]
Definition: DreamSD.h:72
bool doCherenkov_
Definition: DreamSD.h:58
double slopeLY
Definition: DreamSD.h:60
float py_[MAXPHOTONS]
Definition: DreamSD.h:71
void initMap(G4String, const DDCompactView &)
Definition: DreamSD.cc:194
bool useBirk
Definition: DreamSD.h:58
virtual DreamSD::~DreamSD ( )
inlinevirtual

Definition at line 25 of file DreamSD.h.

References getStepInfo(), initRun(), ProcessHits(), and setDetUnitId().

25 {}

Member Function Documentation

double DreamSD::cherenkovDeposit_ ( G4Step *  aStep)
private

Returns the total energy due to Cherenkov radiation.

Definition at line 293 of file DreamSD.cc.

References beta, ALCARECOTkAlJpsiMuMu_cff::charge, funct::cos(), reco::dp, getAverageNumberOfPhotons_(), getPhotonEnergyDeposit_(), LogDebug, materialPropertiesTable, nphotons_, ntuple_, NULL, phi, dataAnalyzerFineBiningParameters_cff::Pmax, px_, py_, pz_, funct::sin(), mathSSE::sqrt(), x_, y_, and z_.

Referenced by getStepInfo().

293  {
294 
295  double cherenkovEnergy = 0;
296  if (!materialPropertiesTable) return cherenkovEnergy;
297  G4Material* material = aStep->GetTrack()->GetMaterial();
298 
299  // Retrieve refractive index
300  G4MaterialPropertyVector* Rindex = materialPropertiesTable->GetProperty("RINDEX");
301  if ( Rindex == NULL ) {
302  edm::LogWarning("EcalSim") << "Couldn't retrieve refractive index";
303  return cherenkovEnergy;
304  }
305 
306  // V.Ivanchenko - temporary close log output for 9.5
307  // Material refraction properties
308  int Rlength = Rindex->GetVectorLength() - 1;
309  double Pmin = Rindex->Energy(0);
310  double Pmax = Rindex->Energy(Rlength);
311  LogDebug("EcalSim") << "Material properties: " << "\n"
312  << " Pmin = " << Pmin
313  << " Pmax = " << Pmax;
314 
315  // Get particle properties
316  G4StepPoint* pPreStepPoint = aStep->GetPreStepPoint();
317  G4StepPoint* pPostStepPoint = aStep->GetPostStepPoint();
318  G4ThreeVector x0 = pPreStepPoint->GetPosition();
319  G4ThreeVector p0 = aStep->GetDeltaPosition().unit();
320  const G4DynamicParticle* aParticle = aStep->GetTrack()->GetDynamicParticle();
321  const double charge = aParticle->GetDefinition()->GetPDGCharge();
322  // beta is averaged over step
323  double beta = 0.5*( pPreStepPoint->GetBeta() + pPostStepPoint->GetBeta() );
324  double BetaInverse = 1.0/beta;
325 
326  LogDebug("EcalSim") << "Particle properties: " << "\n"
327  << " charge = " << charge
328  << " beta = " << beta;
329 
330  // Now get number of photons generated in this step
331  double meanNumberOfPhotons = getAverageNumberOfPhotons_( charge, beta, material, Rindex );
332  if ( meanNumberOfPhotons <= 0.0 ) { // Don't do anything
333  LogDebug("EcalSim") << "Mean number of photons is zero: " << meanNumberOfPhotons
334  << ", stopping here";
335  return cherenkovEnergy;
336  }
337 
338  // number of photons is in unit of Geant4...
339  meanNumberOfPhotons *= aStep->GetStepLength();
340 
341  // Now get a poisson distribution
342  int numPhotons = static_cast<int>( G4Poisson(meanNumberOfPhotons) );
343  //edm::LogVerbatim("EcalSim") << "Number of photons = " << numPhotons;
344  if ( numPhotons <= 0 ) {
345  LogDebug("EcalSim") << "Poission number of photons is zero: " << numPhotons
346  << ", stopping here";
347  return cherenkovEnergy;
348  }
349 
350  // Material refraction properties
351  double dp = Pmax - Pmin;
352  double maxCos = BetaInverse / (*Rindex)[Rlength];
353  double maxSin2 = (1.0 - maxCos) * (1.0 + maxCos);
354 
355  // Finally: get contribution of each photon
356  for ( int iPhoton = 0; iPhoton<numPhotons; ++iPhoton ) {
357 
358  // Determine photon momentum
359  double randomNumber;
360  double sampledMomentum, sampledRI;
361  double cosTheta, sin2Theta;
362 
363  // sample a momentum (not sure why this is needed!)
364  do {
365  randomNumber = G4UniformRand();
366  sampledMomentum = Pmin + randomNumber * dp;
367  sampledRI = Rindex->Value(sampledMomentum);
368  cosTheta = BetaInverse / sampledRI;
369 
370  sin2Theta = (1.0 - cosTheta)*(1.0 + cosTheta);
371  randomNumber = G4UniformRand();
372 
373  } while (randomNumber*maxSin2 > sin2Theta);
374 
375  // Generate random position of photon on cone surface
376  // defined by Theta
377  randomNumber = G4UniformRand();
378 
379  double phi = twopi*randomNumber;
380  double sinPhi = sin(phi);
381  double cosPhi = cos(phi);
382 
383  // Create photon momentum direction vector
384  // The momentum direction is still w.r.t. the coordinate system where the primary
385  // particle direction is aligned with the z axis
386  double sinTheta = sqrt(sin2Theta);
387  double px = sinTheta*cosPhi;
388  double py = sinTheta*sinPhi;
389  double pz = cosTheta;
390  G4ThreeVector photonDirection(px, py, pz);
391 
392  // Rotate momentum direction back to global (crystal) reference system
393  photonDirection.rotateUz(p0);
394 
395  // Create photon position and momentum
396  randomNumber = G4UniformRand();
397  G4ThreeVector photonPosition = x0 + randomNumber * aStep->GetDeltaPosition();
398  G4ThreeVector photonMomentum = sampledMomentum*photonDirection;
399 
400  // Collect energy on APD
401  cherenkovEnergy += getPhotonEnergyDeposit_( photonMomentum, photonPosition, aStep );
402 
403  // Ntuple variables
404  nphotons_ = numPhotons;
405  px_[iPhoton] = photonMomentum.x();
406  py_[iPhoton] = photonMomentum.y();
407  pz_[iPhoton] = photonMomentum.z();
408  x_[iPhoton] = photonPosition.x();
409  y_[iPhoton] = photonPosition.y();
410  z_[iPhoton] = photonPosition.z();
411  }
412 
413  // Fill ntuple
414  ntuple_->Fill();
415 
416 
417  return cherenkovEnergy;
418 
419 }
#define LogDebug(id)
const double beta
double getPhotonEnergyDeposit_(const G4ParticleMomentum &p, const G4ThreeVector &x, const G4Step *aStep)
Returns energy deposit for a given photon.
Definition: DreamSD.cc:560
float y_[MAXPHOTONS]
Definition: DreamSD.h:72
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
double getAverageNumberOfPhotons_(const double charge, const double beta, const G4Material *aMaterial, G4MaterialPropertyVector *rIndex)
Returns average number of photons created by track.
Definition: DreamSD.cc:425
#define NULL
Definition: scimark2.h:8
float px_[MAXPHOTONS]
Definition: DreamSD.h:71
TTree * ntuple_
Definition: DreamSD.h:69
float z_[MAXPHOTONS]
Definition: DreamSD.h:72
T sqrt(T t)
Definition: SSEVec.h:18
int nphotons_
Definition: DreamSD.h:70
float pz_[MAXPHOTONS]
Definition: DreamSD.h:71
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
G4MaterialPropertiesTable * materialPropertiesTable
Definition: DreamSD.h:67
auto dp
Definition: deltaR.h:22
float x_[MAXPHOTONS]
Definition: DreamSD.h:72
float py_[MAXPHOTONS]
Definition: DreamSD.h:71
const double DreamSD::crystalLength ( G4LogicalVolume *  lv) const
private

Definition at line 270 of file DreamSD.cc.

References xtalLMap.

Referenced by curve_LY(), and getPhotonEnergyDeposit_().

270  {
271 
272  double length= -1.;
273  DimensionMap::const_iterator ite = xtalLMap.find(lv);
274  if (ite != xtalLMap.end()) length = ite->second.first;
275  return length;
276 
277 }
DimensionMap xtalLMap
Definition: DreamSD.h:61
const double DreamSD::crystalWidth ( G4LogicalVolume *  lv) const
private

Definition at line 280 of file DreamSD.cc.

References ApeEstimator_cff::width, and xtalLMap.

Referenced by getPhotonEnergyDeposit_().

280  {
281 
282  double width= -1.;
283  DimensionMap::const_iterator ite = xtalLMap.find(lv);
284  if (ite != xtalLMap.end()) width = ite->second.second;
285  return width;
286 
287 }
DimensionMap xtalLMap
Definition: DreamSD.h:61
double DreamSD::curve_LY ( G4Step *  aStep,
int  flag 
)
private

Definition at line 239 of file DreamSD.cc.

References crystalLength(), LogDebug, CaloSD::setToLocal(), slopeLY, and mps_merge::weight.

Referenced by getStepInfo().

239  {
240 
241  G4StepPoint* stepPoint = aStep->GetPreStepPoint();
242  G4LogicalVolume* lv = stepPoint->GetTouchable()->GetVolume(0)->GetLogicalVolume();
243  G4String nameVolume= lv->GetName();
244 
245  double weight = 1.;
246  G4ThreeVector localPoint = setToLocal(stepPoint->GetPosition(),
247  stepPoint->GetTouchable());
248  double crlength = crystalLength(lv);
249  double localz = localPoint.x();
250  double dapd = 0.5 * crlength - flag*localz; // Distance from closest APD
251  if (dapd >= -0.1 || dapd <= crlength+0.1) {
252  if (dapd <= 100.)
253  weight = 1.0 + slopeLY - dapd * 0.01 * slopeLY;
254  } else {
255  edm::LogWarning("EcalSim") << "DreamSD: light coll curve : wrong distance "
256  << "to APD " << dapd << " crlength = "
257  << crlength << " crystal name = " << nameVolume
258  << " z of localPoint = " << localz
259  << " take weight = " << weight;
260  }
261  LogDebug("EcalSim") << "DreamSD, light coll curve : " << dapd
262  << " crlength = " << crlength
263  << " crystal name = " << nameVolume
264  << " z of localPoint = " << localz
265  << " take weight = " << weight;
266  return weight;
267 }
#define LogDebug(id)
Definition: weight.py:1
double slopeLY
Definition: DreamSD.h:60
const double crystalLength(G4LogicalVolume *) const
Definition: DreamSD.cc:270
G4ThreeVector setToLocal(const G4ThreeVector &, const G4VTouchable *)
Definition: CaloSD.cc:296
double DreamSD::getAverageNumberOfPhotons_ ( const double  charge,
const double  beta,
const G4Material *  aMaterial,
G4MaterialPropertyVector *  rIndex 
)
private

Returns average number of photons created by track.

Definition at line 425 of file DreamSD.cc.

References beta, chAngleIntegrals_, reco::dp, LogDebug, and dataAnalyzerFineBiningParameters_cff::Pmax.

Referenced by cherenkovDeposit_().

429 {
430  const G4double rFact = 369.81/(eV * cm);
431 
432  if( beta <= 0.0 ) return 0.0;
433 
434  double BetaInverse = 1./beta;
435 
436  // Vectors used in computation of Cerenkov Angle Integral:
437  // - Refraction Indices for the current material
438  // - new G4PhysicsOrderedFreeVector allocated to hold CAI's
439 
440  // Min and Max photon momenta
441  int Rlength = Rindex->GetVectorLength() - 1;
442  double Pmin = Rindex->Energy(0);
443  double Pmax = Rindex->Energy(Rlength);
444 
445  // Min and Max Refraction Indices
446  double nMin = (*Rindex)[0];
447  double nMax = (*Rindex)[Rlength];
448 
449  // Max Cerenkov Angle Integral
450  double CAImax = chAngleIntegrals_->GetMaxValue();
451 
452  double dp = 0., ge = 0., CAImin = 0.;
453 
454  // If n(Pmax) < 1/Beta -- no photons generated
455  if ( nMax < BetaInverse) { }
456 
457  // otherwise if n(Pmin) >= 1/Beta -- photons generated
458  else if (nMin > BetaInverse) {
459  dp = Pmax - Pmin;
460  ge = CAImax;
461  }
462  // If n(Pmin) < 1/Beta, and n(Pmax) >= 1/Beta, then
463  // we need to find a P such that the value of n(P) == 1/Beta.
464  // Interpolation is performed by the GetPhotonEnergy() and
465  // GetProperty() methods of the G4MaterialPropertiesTable and
466  // the GetValue() method of G4PhysicsVector.
467  else {
468  Pmin = Rindex->Value(BetaInverse);
469  dp = Pmax - Pmin;
470  // need boolean for current implementation of G4PhysicsVector
471  // ==> being phased out
472  double CAImin = chAngleIntegrals_->Value(Pmin);
473  ge = CAImax - CAImin;
474 
475  }
476 
477  // Calculate number of photons
478  double numPhotons = rFact * charge/eplus * charge/eplus *
479  (dp - ge * BetaInverse*BetaInverse);
480 
481  LogDebug("EcalSim") << "@SUB=getAverageNumberOfPhotons"
482  << "CAImin = " << CAImin << "\n"
483  << "CAImax = " << CAImax << "\n"
484  << "dp = " << dp << ", ge = " << ge << "\n"
485  << "numPhotons = " << numPhotons;
486 
487 
488 
489  return numPhotons;
490 
491 }
#define LogDebug(id)
const double beta
std::auto_ptr< G4PhysicsOrderedFreeVector > chAngleIntegrals_
Table of Cherenkov angle integrals vs photon momentum.
Definition: DreamSD.h:66
auto dp
Definition: deltaR.h:22
double DreamSD::getPhotonEnergyDeposit_ ( const G4ParticleMomentum &  p,
const G4ThreeVector &  x,
const G4Step *  aStep 
)
private

Returns energy deposit for a given photon.

Definition at line 560 of file DreamSD.cc.

References crystalLength(), crystalWidth(), PMTResponse::getEfficiency(), LogDebug, and y.

Referenced by cherenkovDeposit_().

563 {
564 
565  double energy = 0;
566 
567  // Crystal dimensions
568 
569  //edm::LogVerbatim("EcalSim") << p << x;
570 
571  // 1. Check if this photon goes straight to the APD:
572  // - assume that APD is at x=xtalLength/2.0
573  // - extrapolate from x=x0 to x=xtalLength/2.0 using momentum in x-y
574 
575  G4StepPoint* stepPoint = aStep->GetPreStepPoint();
576  G4LogicalVolume* lv = stepPoint->GetTouchable()->GetVolume(0)->GetLogicalVolume();
577  G4String nameVolume= lv->GetName();
578 
579  double crlength = crystalLength(lv);
580  double crwidth = crystalWidth(lv);
581  double dapd = 0.5 * crlength - x.x(); // Distance from closest APD
582  double y = p.y()/p.x()*dapd;
583 
584  LogDebug("EcalSim") << "Distance to APD: " << dapd
585  << " - y at APD: " << y;
586 
587  // Not straight: compute probability
588  if ( fabs(y)>crwidth*0.5 ) {
589 
590  }
591 
592  // 2. Retrieve efficiency for this wavelength (in nm, from MeV)
593  double waveLength = p.mag()*1.239e8;
594 
595 
596  energy = p.mag()*PMTResponse::getEfficiency(waveLength);
597 
598  LogDebug("EcalSim") << "Wavelength: " << waveLength << " - Energy: " << energy;
599 
600  return energy;
601 
602 }
#define LogDebug(id)
const double crystalWidth(G4LogicalVolume *) const
Definition: DreamSD.cc:280
const double crystalLength(G4LogicalVolume *) const
Definition: DreamSD.cc:270
static const double getEfficiency(const double &waveLengthNm)
Return efficiency for given photon wavelength (in nm)
Definition: PMTResponse.cc:6
bool DreamSD::getStepInfo ( G4Step *  aStep)
protectedvirtual

Reimplemented from CaloSD.

Definition at line 99 of file DreamSD.cc.

References birk1, birk2, birk3, cherenkovDeposit_(), CaloSD::currentID, curve_LY(), TauDecayModes::dec, doCherenkov_, CaloSD::edepositEM, CaloSD::edepositHAD, RemoveAddSevLevel::flag, CaloSD::getAttenuation(), TrackInformation::getIDonCaloSurface(), LogDebug, MeV, CaloSD::preStepPoint, setDetUnitId(), CaloHitID::setID(), side, CaloSD::theTrack, ntuplemaker::time, CaloHitID::unitID(), useBirk, and mps_merge::weight.

Referenced by ProcessHits(), and ~DreamSD().

99  {
100 
101  preStepPoint = aStep->GetPreStepPoint();
102  theTrack = aStep->GetTrack();
103  G4String nameVolume = preStepPoint->GetPhysicalVolume()->GetName();
104 
105  // take into account light collection curve for crystals
106  double weight = 1.;
107  weight *= curve_LY(aStep, side);
108  if (useBirk) weight *= getAttenuation(aStep, birk1, birk2, birk3);
109  edepositEM = aStep->GetTotalEnergyDeposit() * weight;
110  LogDebug("EcalSim") << "DreamSD:: " << nameVolume << " Side " << side
111  <<" Light Collection Efficiency " << weight
112  << " Weighted Energy Deposit " << edepositEM/MeV
113  << " MeV";
114  // Get cherenkov contribution
115  if ( doCherenkov_ ) {
116  edepositHAD = cherenkovDeposit_( aStep );
117  } else {
118  edepositHAD = 0;
119  }
120 
121  double time = (aStep->GetPostStepPoint()->GetGlobalTime())/nanosecond;
122  unsigned int unitID= setDetUnitId(aStep);
123  if (side < 0) unitID++;
124  TrackInformation * trkInfo = (TrackInformation *)(theTrack->GetUserInformation());
125  int primaryID;
126 
127  if (trkInfo)
128  primaryID = trkInfo->getIDonCaloSurface();
129  else
130  primaryID = 0;
131 
132  if (primaryID == 0) {
133  edm::LogWarning("EcalSim") << "CaloSD: Problem with primaryID **** set by "
134  << "force to TkID **** "
135  << theTrack->GetTrackID() << " in Volume "
136  << preStepPoint->GetTouchable()->GetVolume(0)->GetName();
137  primaryID = theTrack->GetTrackID();
138  }
139 
140  bool flag = (unitID > 0);
141  G4TouchableHistory* touch =(G4TouchableHistory*)(theTrack->GetTouchable());
142  if (flag) {
143  currentID.setID(unitID, time, primaryID, 0);
144 
145  LogDebug("EcalSim") << "CaloSD:: GetStepInfo for"
146  << " PV " << touch->GetVolume(0)->GetName()
147  << " PVid = " << touch->GetReplicaNumber(0)
148  << " MVid = " << touch->GetReplicaNumber(1)
149  << " Unit " << currentID.unitID()
150  << " Edeposit = " << edepositEM << " " << edepositHAD;
151  } else {
152  LogDebug("EcalSim") << "CaloSD:: GetStepInfo for"
153  << " PV " << touch->GetVolume(0)->GetName()
154  << " PVid = " << touch->GetReplicaNumber(0)
155  << " MVid = " << touch->GetReplicaNumber(1)
156  << " Unit " << std::hex << unitID << std::dec
157  << " Edeposit = " << edepositEM << " " << edepositHAD;
158  }
159  return flag;
160 
161 }
#define LogDebug(id)
float edepositEM
Definition: CaloSD.h:121
int getIDonCaloSurface() const
Definition: weight.py:1
double birk1
Definition: DreamSD.h:59
double birk3
Definition: DreamSD.h:59
virtual uint32_t setDetUnitId(G4Step *)
Definition: DreamSD.cc:185
const double MeV
float edepositHAD
Definition: CaloSD.h:121
int side
Definition: DreamSD.h:63
double birk2
Definition: DreamSD.h:59
double getAttenuation(G4Step *aStep, double birk1, double birk2, double birk3)
Definition: CaloSD.cc:465
G4Track * theTrack
Definition: CaloSD.h:118
void setID(uint32_t unitID, double timeSlice, int trackID, uint16_t depth=0)
Definition: CaloHitID.cc:44
G4StepPoint * preStepPoint
Definition: CaloSD.h:120
double cherenkovDeposit_(G4Step *aStep)
Returns the total energy due to Cherenkov radiation.
Definition: DreamSD.cc:293
CaloHitID currentID
Definition: CaloSD.h:117
bool doCherenkov_
Definition: DreamSD.h:58
uint32_t unitID() const
Definition: CaloHitID.h:22
double curve_LY(G4Step *, int)
Definition: DreamSD.cc:239
bool useBirk
Definition: DreamSD.h:58
void DreamSD::initMap ( G4String  sd,
const DDCompactView cpv 
)
private

Definition at line 194 of file DreamSD.cc.

References ALCARECOTkAlBeamHalo_cff::filter, DDFilteredView::firstChild(), mps_fire::i, LogDebug, DDFilteredView::logicalPart(), DDName::name(), SensitiveDetector::name, DDBase< N, C >::name(), DDFilteredView::next(), DDSolid::parameters(), DDSolid::shape(), DDLogicalPart::solid(), ApeEstimator_cff::width, and xtalLMap.

Referenced by DreamSD().

194  {
195 
196  G4String attribute = "ReadOutName";
198  DDFilteredView fv(cpv,filter);
199  fv.firstChild();
200 
201  const G4LogicalVolumeStore * lvs = G4LogicalVolumeStore::GetInstance();
202  std::vector<G4LogicalVolume *>::const_iterator lvcite;
203  bool dodet=true;
204  while (dodet) {
205  const DDSolid & sol = fv.logicalPart().solid();
206  std::vector<double> paras(sol.parameters());
207  G4String name = sol.name().name();
208  G4LogicalVolume* lv=0;
209  for (lvcite = lvs->begin(); lvcite != lvs->end(); lvcite++)
210  if ((*lvcite)->GetName() == name) {
211  lv = (*lvcite);
212  break;
213  }
214  LogDebug("EcalSim") << "DreamSD::initMap (for " << sd << "): Solid "
215  << name << " Shape " << sol.shape() <<" Parameter 0 = "
216  << paras[0] << " Logical Volume " << lv;
217  double length = 0, width = 0;
218  // Set length to be the largest size, width the smallest
219  std::sort( paras.begin(), paras.end() );
220  length = 2.0*paras.back();
221  width = 2.0*paras.front();
222  xtalLMap.insert( std::pair<G4LogicalVolume*,Doubles>(lv,Doubles(length,width)) );
223  dodet = fv.next();
224  }
225  LogDebug("EcalSim") << "DreamSD: Length Table for " << attribute << " = "
226  << sd << ":";
227  DimensionMap::const_iterator ite = xtalLMap.begin();
228  int i=0;
229  for (; ite != xtalLMap.end(); ite++, i++) {
230  G4String name = "Unknown";
231  if (ite->first != 0) name = (ite->first)->GetName();
232  LogDebug("EcalSim") << " " << i << " " << ite->first << " " << name
233  << " L = " << ite->second.first
234  << " W = " << ite->second.second;
235  }
236 }
#define LogDebug(id)
const std::vector< double > & parameters(void) const
Give the parameters of the solid.
Definition: DDSolid.cc:150
const N & name() const
Definition: DDBase.h:78
std::pair< double, double > Doubles
Definition: DreamSD.h:36
A DDSolid represents the shape of a part.
Definition: DDSolid.h:38
DDSolidShape shape(void) const
The type of the solid.
Definition: DDSolid.cc:144
DimensionMap xtalLMap
Definition: DreamSD.h:61
double sd
const std::string & name() const
Returns the name.
Definition: DDName.cc:90
void DreamSD::initRun ( void  )
protectedvirtual

Reimplemented from CaloSD.

Definition at line 165 of file DreamSD.cc.

References materialPropertiesTable, setPbWO2MaterialProperties_(), and xtalLMap.

Referenced by ~DreamSD().

165  {
166 
167  // Get the material and set properties if needed
168  DimensionMap::const_iterator ite = xtalLMap.begin();
169  G4LogicalVolume* lv = (ite->first);
170  G4Material* material = lv->GetMaterial();
171  edm::LogInfo("EcalSim") << "DreamSD::initRun: Initializes for material "
172  << material->GetName() << " in " << lv->GetName();
173  materialPropertiesTable = material->GetMaterialPropertiesTable();
174  if ( !materialPropertiesTable ) {
175  if ( !setPbWO2MaterialProperties_( material ) ) {
176  edm::LogWarning("EcalSim") << "Couldn't retrieve material properties table\n"
177  << " Material = " << material->GetName();
178  }
179  materialPropertiesTable = material->GetMaterialPropertiesTable();
180  }
181 }
bool setPbWO2MaterialProperties_(G4Material *aMaterial)
Sets material properties at run-time...
Definition: DreamSD.cc:497
G4MaterialPropertiesTable * materialPropertiesTable
Definition: DreamSD.h:67
DimensionMap xtalLMap
Definition: DreamSD.h:61
bool DreamSD::ProcessHits ( G4Step *  step,
G4TouchableHistory *  tHistory 
)
virtual

Reimplemented from CaloSD.

Definition at line 77 of file DreamSD.cc.

References CaloSD::createNewHit(), CaloSD::currentHit, CaloSD::edepositEM, CaloSD::edepositHAD, getStepInfo(), CaloSD::hitExists(), NULL, readBothSide_, and side.

Referenced by ~DreamSD().

77  {
78 
79  if (aStep == NULL) {
80  return true;
81  } else {
82  side = 1;
83  if (getStepInfo(aStep)) {
84  if (hitExists() == false && edepositEM+edepositHAD>0.)
86  if (readBothSide_) {
87  side = -1;
88  getStepInfo(aStep);
89  if (hitExists() == false && edepositEM+edepositHAD>0.)
91  }
92  }
93  }
94  return true;
95 }
float edepositEM
Definition: CaloSD.h:121
bool readBothSide_
Definition: DreamSD.h:58
virtual G4bool getStepInfo(G4Step *aStep)
Definition: DreamSD.cc:99
#define NULL
Definition: scimark2.h:8
float edepositHAD
Definition: CaloSD.h:121
int side
Definition: DreamSD.h:63
CaloG4Hit * currentHit
Definition: CaloSD.h:128
G4bool hitExists()
Definition: CaloSD.cc:310
CaloG4Hit * createNewHit()
Definition: CaloSD.cc:363
uint32_t DreamSD::setDetUnitId ( G4Step *  aStep)
virtual

Implements CaloSD.

Definition at line 185 of file DreamSD.cc.

References hcalTTPDigis_cfi::id, and LogDebug.

Referenced by getStepInfo(), and ~DreamSD().

185  {
186  const G4VTouchable* touch = aStep->GetPreStepPoint()->GetTouchable();
187  uint32_t id = (touch->GetReplicaNumber(1))*10 + (touch->GetReplicaNumber(0));
188  LogDebug("EcalSim") << "DreamSD:: ID " << id;
189  return id;
190 }
#define LogDebug(id)
bool DreamSD::setPbWO2MaterialProperties_ ( G4Material *  aMaterial)
private

Sets material properties at run-time...

Definition at line 497 of file DreamSD.cc.

References chAngleIntegrals_, diffTreeTool::index, LogDebug, and AlCaHLTBitMon_QueryRunRegistry::string.

Referenced by initRun().

497  {
498 
499  std::string pbWO2Name("E_PbWO4");
500  if ( pbWO2Name != aMaterial->GetName() ) { // Wrong material!
501  edm::LogWarning("EcalSim") << "This is not the right material: "
502  << "expecting " << pbWO2Name
503  << ", got " << aMaterial->GetName();
504  return false;
505  }
506 
507  G4MaterialPropertiesTable* table = new G4MaterialPropertiesTable();
508 
509  // Refractive index as a function of photon momentum
510  // FIXME: Should somehow put that in the configuration
511  const int nEntries = 14;
512  double PhotonEnergy[nEntries] = { 1.7712*eV, 1.8368*eV, 1.90745*eV, 1.98375*eV, 2.0664*eV,
513  2.15625*eV, 2.25426*eV, 2.3616*eV, 2.47968*eV, 2.61019*eV,
514  2.75521*eV, 2.91728*eV, 3.09961*eV, 3.30625*eV };
515  double RefractiveIndex[nEntries] = { 2.17728, 2.18025, 2.18357, 2.18753, 2.19285,
516  2.19813, 2.20441, 2.21337, 2.22328, 2.23619,
517  2.25203, 2.27381, 2.30282, 2.34666 };
518 
519  table->AddProperty( "RINDEX", PhotonEnergy, RefractiveIndex, nEntries );
520  aMaterial->SetMaterialPropertiesTable(table); // FIXME: could this leak? What does G4 do?
521 
522  // Calculate Cherenkov angle integrals:
523  // This is an ad-hoc solution (we hold it in the class, not in the material)
525  std::auto_ptr<G4PhysicsOrderedFreeVector>( new G4PhysicsOrderedFreeVector() );
526 
527  int index = 0;
528  double currentRI = RefractiveIndex[index];
529  double currentPM = PhotonEnergy[index];
530  double currentCAI = 0.0;
531  chAngleIntegrals_->InsertValues(currentPM, currentCAI);
532  double prevPM = currentPM;
533  double prevCAI = currentCAI;
534  double prevRI = currentRI;
535  while ( ++index < nEntries ) {
536  currentRI = RefractiveIndex[index];
537  currentPM = PhotonEnergy[index];
538  currentCAI = 0.5*(1.0/(prevRI*prevRI) + 1.0/(currentRI*currentRI));
539  currentCAI = prevCAI + (currentPM - prevPM) * currentCAI;
540 
541  chAngleIntegrals_->InsertValues(currentPM, currentCAI);
542 
543  prevPM = currentPM;
544  prevCAI = currentCAI;
545  prevRI = currentRI;
546  }
547 
548  LogDebug("EcalSim") << "Material properties set for " << aMaterial->GetName();
549 
550  return true;
551 
552 }
#define LogDebug(id)
std::auto_ptr< G4PhysicsOrderedFreeVector > chAngleIntegrals_
Table of Cherenkov angle integrals vs photon momentum.
Definition: DreamSD.h:66

Member Data Documentation

double DreamSD::birk1
private

Definition at line 59 of file DreamSD.h.

Referenced by DreamSD(), and getStepInfo().

double DreamSD::birk2
private

Definition at line 59 of file DreamSD.h.

Referenced by DreamSD(), and getStepInfo().

double DreamSD::birk3
private

Definition at line 59 of file DreamSD.h.

Referenced by DreamSD(), and getStepInfo().

std::auto_ptr<G4PhysicsOrderedFreeVector> DreamSD::chAngleIntegrals_
private

Table of Cherenkov angle integrals vs photon momentum.

Definition at line 66 of file DreamSD.h.

Referenced by getAverageNumberOfPhotons_(), and setPbWO2MaterialProperties_().

bool DreamSD::doCherenkov_
private

Definition at line 58 of file DreamSD.h.

Referenced by DreamSD(), and getStepInfo().

G4MaterialPropertiesTable* DreamSD::materialPropertiesTable
private

Definition at line 67 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and initRun().

int DreamSD::nphotons_
private

Definition at line 70 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and DreamSD().

TTree* DreamSD::ntuple_
private

Definition at line 69 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and DreamSD().

float DreamSD::px_[MAXPHOTONS]
private

Definition at line 71 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and DreamSD().

float DreamSD::py_[MAXPHOTONS]
private

Definition at line 71 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and DreamSD().

float DreamSD::pz_[MAXPHOTONS]
private

Definition at line 71 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and DreamSD().

bool DreamSD::readBothSide_
private

Definition at line 58 of file DreamSD.h.

Referenced by DreamSD(), and ProcessHits().

int DreamSD::side
private

Definition at line 63 of file DreamSD.h.

Referenced by getStepInfo(), and ProcessHits().

double DreamSD::slopeLY
private

Definition at line 60 of file DreamSD.h.

Referenced by curve_LY(), and DreamSD().

bool DreamSD::useBirk
private

Definition at line 58 of file DreamSD.h.

Referenced by DreamSD(), and getStepInfo().

float DreamSD::x_[MAXPHOTONS]
private

Definition at line 72 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and DreamSD().

DimensionMap DreamSD::xtalLMap
private

Definition at line 61 of file DreamSD.h.

Referenced by crystalLength(), crystalWidth(), initMap(), and initRun().

float DreamSD::y_[MAXPHOTONS]
private

Definition at line 72 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and DreamSD().

float DreamSD::z_[MAXPHOTONS]
private

Definition at line 72 of file DreamSD.h.

Referenced by cherenkovDeposit_(), and DreamSD().