CMS 3D CMS Logo

Bremsstrahlung.cc
Go to the documentation of this file.
6 
7 #include <cmath>
8 #include <memory>
9 
10 #include <Math/RotationY.h>
11 #include <Math/RotationZ.h>
12 
17 
19 // Author: Patrick Janot
20 // Date: 25-Dec-2003
21 //
22 // Revision: Class structure modified to match SimplifiedGeometryPropagator
23 // Fixed a bug in which particles could radiate more energy than they have
24 // S. Kurz, 29 May 2017
26 
27 namespace fastsim {
29 
34  public:
37 
39  ~Bremsstrahlung() override { ; };
40 
42 
48  void interact(Particle& particle,
49  const SimplifiedGeometry& layer,
50  std::vector<std::unique_ptr<Particle> >& secondaries,
51  const RandomEngineAndDistribution& random) override;
52 
53  private:
55 
61  math::XYZTLorentzVector brem(Particle& particle, double xmin, const RandomEngineAndDistribution& random) const;
62 
64 
71  double gbteth(const double ener,
72  const double partm,
73  const double efrac,
74  const RandomEngineAndDistribution& random) const;
75 
78  double Z_;
79  };
80 } // namespace fastsim
81 
84  // Set the minimal photon energy for a Brem from e+/-
85  minPhotonEnergy_ = cfg.getParameter<double>("minPhotonEnergy");
86  minPhotonEnergyFraction_ = cfg.getParameter<double>("minPhotonEnergyFraction");
87  // Material properties
88  Z_ = cfg.getParameter<double>("Z");
89 }
90 
92  const SimplifiedGeometry& layer,
93  std::vector<std::unique_ptr<fastsim::Particle> >& secondaries,
94  const RandomEngineAndDistribution& random) {
95  // only consider electrons and positrons
96  if (std::abs(particle.pdgId()) != 11) {
97  return;
98  }
99 
100  double radLengths = layer.getThickness(particle.position(), particle.momentum());
101  //
102  // no material
103  //
104  if (radLengths < 1E-10) {
105  return;
106  }
107 
108  // Protection : Just stop the electron if more than 1 radiation lengths.
109  // This case corresponds to an electron entering the layer parallel to
110  // the layer axis - no reliable simulation can be done in that case...
111  if (radLengths > 4.) {
112  particle.momentum().SetXYZT(0., 0., 0., 0.);
113  return;
114  }
115 
116  // electron must have more energy than minimum photon energy
117  if (particle.momentum().E() - particle.momentum().mass() < minPhotonEnergy_) {
118  return;
119  }
120 
121  // Hard brem probability with a photon Energy above threshold.
122  double xmin = std::max(minPhotonEnergy_ / particle.momentum().E(), minPhotonEnergyFraction_);
123  if (xmin >= 1. || xmin <= 0.) {
124  return;
125  }
126 
127  // probability to radiate a photon
128  double bremProba =
129  radLengths * (4. / 3. * std::log(1. / xmin) - 4. / 3. * (1. - xmin) + 1. / 2. * (1. - xmin * xmin));
130 
131  // Number of photons to be radiated.
132  unsigned int nPhotons = random.poissonShoot(bremProba);
133  if (nPhotons == 0) {
134  return;
135  }
136 
137  // Needed to rotate photons to the lab frame
138  double theta = particle.momentum().Theta();
139  double phi = particle.momentum().Phi();
140  double m2dontchange = particle.momentum().mass() * particle.momentum().mass();
141 
142  // Calculate energy of these photons and add them to the event
143  for (unsigned int i = 0; i < nPhotons; ++i) {
144  // Throw momentum of the photon
145  math::XYZTLorentzVector photonMom = brem(particle, xmin, random);
146 
147  // Check that there is enough energy left.
148  if (particle.momentum().E() - particle.momentum().mass() < photonMom.E())
149  break;
150 
151  // Rotate to the lab frame
152  photonMom = ROOT::Math::RotationZ(phi) * (ROOT::Math::RotationY(theta) * photonMom);
153 
154  // Add a photon
155  secondaries.emplace_back(new fastsim::Particle(22, particle.position(), photonMom));
156 
157  // Update the original e+/-
158  particle.momentum() -= photonMom;
159  particle.momentum().SetXYZT(particle.momentum().px(),
160  particle.momentum().py(),
161  particle.momentum().pz(),
162  sqrt(pow(particle.momentum().P(), 2) + m2dontchange));
163  }
164 }
165 
167  double xmin,
168  const RandomEngineAndDistribution& random) const {
169  double xp = 0;
170  double weight = 0.;
171 
172  do {
173  xp = xmin * std::exp(-std::log(xmin) * random.flatShoot());
174  weight = 1. - xp + 3. / 4. * xp * xp;
175  } while (weight < random.flatShoot());
176 
177  // Have photon energy. Now generate angles with respect to the z axis
178  // defined by the incoming particle's momentum.
179 
180  // Isotropic in phi
181  const double phi = random.flatShoot() * 2. * M_PI;
182  // theta from universal distribution
183  const double theta = gbteth(particle.momentum().E(), fastsim::Constants::eMass, xp, random) *
184  fastsim::Constants::eMass / particle.momentum().E();
185 
186  // Make momentum components
187  double stheta = std::sin(theta);
188  double ctheta = std::cos(theta);
189  double sphi = std::sin(phi);
190  double cphi = std::cos(phi);
191 
192  return xp * particle.momentum().E() * math::XYZTLorentzVector(stheta * cphi, stheta * sphi, ctheta, 1.);
193 }
194 
195 double fastsim::Bremsstrahlung::gbteth(const double ener,
196  const double partm,
197  const double efrac,
198  const RandomEngineAndDistribution& random) const {
199  // Details on implementation here
200  // http://www.dnp.fmph.uniba.sk/cernlib/asdoc/geant_html3/node299.html#GBTETH
201  // http://svn.cern.ch/guest/AliRoot/tags/v3-07-03/GEANT321/gphys/gbteth.F
202 
203  const double alfa = 0.625;
204 
205  const double d = 0.13 * (0.8 + 1.3 / Z_) * (100.0 + (1.0 / ener)) * (1.0 + efrac);
206  const double w1 = 9.0 / (9.0 + d);
207  const double umax = ener * M_PI / partm;
208  double u;
209 
210  do {
211  double beta = (random.flatShoot() <= w1) ? alfa : 3.0 * alfa;
212  u = -std::log(random.flatShoot() * random.flatShoot()) / beta;
213  } while (u >= umax);
214 
215  return u;
216 }
217 
double gbteth(const double ener, const double partm, const double efrac, const RandomEngineAndDistribution &random) const
A universal angular distribution.
Implementation of a generic detector layer (base class for forward/barrel layers).
math::XYZTLorentzVector brem(Particle &particle, double xmin, const RandomEngineAndDistribution &random) const
Compute Brem photon energy and angles, if any.
double minPhotonEnergy_
Cut on minimum energy of bremsstrahlung photons.
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
void interact(Particle &particle, const SimplifiedGeometry &layer, std::vector< std::unique_ptr< Particle > > &secondaries, const RandomEngineAndDistribution &random) override
Perform the interaction.
double Z_
Atomic number of material (usually silicon Z=14)
const math::XYZTLorentzVector & position() const
Return position of the particle.
Definition: Particle.h:140
Definition: weight.py:1
static double constexpr eMass
Electron mass[GeV].
Definition: Constants.h:13
Bremsstrahlung(const std::string &name, const edm::ParameterSet &cfg)
Constructor.
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:29
Base class for any interaction model between a particle and a tracker layer.
T sqrt(T t)
Definition: SSEVec.h:23
~Bremsstrahlung() override
Default destructor.
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
d
Definition: ztail.py:151
#define M_PI
int pdgId() const
Return pdgId of the particle.
Definition: Particle.h:134
Implementation of Bremsstrahlung from e+/e- in the tracker layers.
const math::XYZTLorentzVector & momentum() const
Return momentum of the particle.
Definition: Particle.h:143
unsigned int poissonShoot(double mean) const
#define DEFINE_EDM_PLUGIN(factory, type, name)
double flatShoot(double xmin=0.0, double xmax=1.0) const
Definition of a generic FastSim Particle which can be propagated through the detector (formerly Parti...
Definition: Particle.h:16
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:29
double minPhotonEnergyFraction_
Cut on minimum fraction of particle&#39;s energy which has to be carried by photon.