#include "AliPythia.h"
#include "AliPythiaRndm.h"
+#include "../FASTSIM/AliFastGlauber.h"
+#include "../FASTSIM/AliQuenchingWeights.h"
+#include "TVector3.h"
ClassImp(AliPythia)
#ifndef WIN32
# define pyclus pyclus_
# define pycell pycell_
+# define pyshow pyshow_
+# define pyrobo pyrobo_
# define type_of_call
#else
# define pyclus PYCLUS
# define pycell PYCELL
+# define pyrobo PYROBO
# define type_of_call _stdcall
#endif
extern "C" void type_of_call pyclus(Int_t & );
extern "C" void type_of_call pycell(Int_t & );
+extern "C" void type_of_call pyshow(Int_t &, Int_t &, Double_t &);
+extern "C" void type_of_call pyrobo(Int_t &, Int_t &, Double_t &, Double_t &, Double_t &, Double_t &, Double_t &);
//_____________________________________________________________________________
// Set random number
if (!AliPythiaRndm::GetPythiaRandom())
AliPythiaRndm::SetPythiaRandom(GetRandom());
-
+ fGlauber = 0;
+ fQuenchingWeights = 0;
}
void AliPythia::ProcInit(Process_t process, Float_t energy, StrucFunc_t strucfunc)
//
// select Pythia min. bias model
SetMSEL(0);
- SetMSUB(92,1); // single diffraction AB-->XB
- SetMSUB(93,1); // single diffraction AB-->AX
- SetMSUB(94,1); // double diffraction
- SetMSUB(95,1); // low pt production
- SetMSTP(81,1); // multiple interactions switched on
- SetMSTP(82,3); // model with varying impact param. & a single Gaussian
- SetPARP(82,3.47); // set value pT_0 for turn-off of the cross section of
- // multiple interaction at a reference energy = 14000 GeV
- SetPARP(89,14000.); // reference energy for the above parameter
- SetPARP(90,0.174); // set exponent for energy dependence of pT_0
+ SetMSUB(92,1); // single diffraction AB-->XB
+ SetMSUB(93,1); // single diffraction AB-->AX
+ SetMSUB(94,1); // double diffraction
+ SetMSUB(95,1); // low pt production
+
+//
+// ATLAS Tuning
+//
+ SetMSTP(51,7); // CTEQ5L pdf
+ SetMSTP(81,1); // Multiple Interactions ON
+ SetMSTP(82,4); // Double Gaussian Model
+
+ SetPARP(82,1.8); // [GeV] PT_min at Ref. energy
+ SetPARP(89,1000.); // [GeV] Ref. energy
+ SetPARP(90,0.16); // 2*epsilon (exponent in power law)
+ SetPARP(83,0.5); // Core density in proton matter distribution (def.value)
+ SetPARP(84,0.5); // Core radius
+ SetPARP(85,0.33); // Regulates gluon prod. mechanism
+ SetPARP(86,0.66); // Regulates gluon prod. mechanism
+ SetPARP(67,1); // Regulates Initial State Radiation
+ break;
case kPyMbNonDiffr:
// Minimum Bias pp-Collisions
//
//
// select Pythia min. bias model
SetMSEL(0);
- SetMSUB(95,1); // low pt production
- SetMSTP(81,1); // multiple interactions switched on
- SetMSTP(82,3); // model with varying impact param. & a single Gaussian
- SetPARP(82,3.47); // set value pT_0 for turn-off of the cross section of
- // multiple interaction at a reference energy = 14000 GeV
- SetPARP(89,14000.); // reference energy for the above parameter
- SetPARP(90,0.174); // set exponent for energy dependence of pT_0
-
+ SetMSUB(95,1); // low pt production
+
+//
+// ATLAS Tuning
+//
+
+ SetMSTP(51,7); // CTEQ5L pdf
+ SetMSTP(81,1); // Multiple Interactions ON
+ SetMSTP(82,4); // Double Gaussian Model
+
+ SetPARP(82,1.8); // [GeV] PT_min at Ref. energy
+ SetPARP(89,1000.); // [GeV] Ref. energy
+ SetPARP(90,0.16); // 2*epsilon (exponent in power law)
+ SetPARP(83,0.5); // Core density in proton matter distribution (def.value)
+ SetPARP(84,0.5); // Core radius
+ SetPARP(85,0.33); // Regulates gluon prod. mechanism
+ SetPARP(86,0.66); // Regulates gluon prod. mechanism
+ SetPARP(67,1); // Regulates Initial State Radiation
break;
case kPyJets:
//
pycell(njet);
}
+void AliPythia::Pyshow(Int_t ip1, Int_t ip2, Double_t qmax)
+{
+// Call Pythia jet reconstruction algorithm
+//
+ Int_t numpart = fPyjets->N;
+ for (Int_t i = 0; i < numpart; i++)
+ {
+ if (fPyjets->K[2][i] == 7) ip1 = i+1;
+ if (fPyjets->K[2][i] == 8) ip2 = i+1;
+ }
+
+
+ qmax = 2. * GetVINT(51);
+ printf("Pyshow %d %d %f", ip1, ip2, qmax);
+
+ pyshow(ip1, ip2, qmax);
+}
+
+void AliPythia::Pyrobo(Int_t imi, Int_t ima, Double_t the, Double_t phi, Double_t bex, Double_t bey, Double_t bez)
+{
+ pyrobo(imi, ima, the, phi, bex, bey, bez);
+}
+
+
+
+void AliPythia::InitQuenching(Float_t cMin, Float_t cMax, Float_t qTransport, Float_t maxLength, Int_t iECMethod)
+{
+// Initializes
+// (1) The quenching model using quenching weights according to C. Salgado and U. Wiedemann
+// (2) The nuclear geometry using the Glauber Model
+//
+
+
+ fGlauber = new AliFastGlauber();
+ fGlauber->Init(2);
+ fGlauber->SetCentralityClass(cMin, cMax);
+
+ fQuenchingWeights = new AliQuenchingWeights();
+ fQuenchingWeights->InitMult();
+ fQuenchingWeights->SetQTransport(qTransport);
+ fQuenchingWeights->SetECMethod(AliQuenchingWeights::kECMethod(iECMethod));
+ fQuenchingWeights->SetLengthMax(Int_t(maxLength));
+ fQuenchingWeights->SampleEnergyLoss();
+
+}
+
+
+void AliPythia::Quench()
+{
+//
+//
+// Simple Jet Quenching routine:
+// =============================
+// The jet formed by all final state partons radiated by the parton created
+// in the hard collisions is quenched by a factor (1-z) using light cone variables in
+// the initial parton reference frame:
+// (E + p_z)new = (1-z) (E + p_z)old
+//
+//
+//
+//
+// The lost momentum is first balanced by one gluon with virtuality > 0.
+// Subsequently the gluon splits to yield two gluons with E = p.
+//
+//
+//
+ const Int_t kGluons = 1;
+
+ Double_t p0[2][5];
+ Double_t p1[2][5];
+ Double_t p2[2][5];
+ Int_t klast[2] = {-1, -1};
+ Int_t kglu[2];
+
+ Int_t numpart = fPyjets->N;
+ Double_t px = 0., py = 0., pz = 0., e = 0., m = 0., p = 0., pt = 0., theta = 0.;
+ Double_t pxq[2], pyq[2], pzq[2], eq[2], yq[2], mq[2], pq[2], phiq[2], thetaq[2], ptq[2];
+ Bool_t quenched[2];
+ Double_t phi;
+ Double_t zInitial[2], wjtKick[2];
+ Int_t imo, kst, pdg;
+//
+// Primary partons
+//
+
+ for (Int_t i = 6; i <= 7; i++) {
+ Int_t j = i - 6;
+
+ pxq[j] = fPyjets->P[0][i];
+ pyq[j] = fPyjets->P[1][i];
+ pzq[j] = fPyjets->P[2][i];
+ eq[j] = fPyjets->P[3][i];
+ mq[j] = fPyjets->P[4][i];
+ yq[j] = 0.5 * TMath::Log((e + pz + 1.e-14) / (e - pz + 1.e-14));
+ pq[j] = TMath::Sqrt(pxq[j] * pxq[j] + pyq[j] * pyq[j] + pzq[j] * pzq[j]);
+ phiq[j] = TMath::Pi()+TMath::ATan2(-pyq[j], -pxq[j]);
+ ptq[j] = TMath::Sqrt(pxq[j] * pxq[j] + pyq[j] * pyq[j]);
+ thetaq[j] = TMath::ATan2(ptq[j], pzq[j]);
+ phi = phiq[j];
+
+ // Quench only central jets
+ if (TMath::Abs(yq[j]) > 2.5) {
+ zInitial[j] = 0.;
+ } else {
+ pdg = fPyjets->K[1][i];
+
+ // Get length in nucleus
+ Double_t l;
+ fGlauber->GetLengthsForPythia(1, &phi, &l, -1.);
+ //
+ // Energy loss for given length and parton typr
+ Int_t itype = (pdg == 21) ? 2 : 1;
+ Double_t eloss = fQuenchingWeights->GetELossRandom(itype, l, eq[j]);
+ //
+ // Extra pt
+ wjtKick[j] = TMath::Sqrt(l * fQuenchingWeights->GetQTransport());
+ //
+ // Fractional energy loss
+ zInitial[j] = eloss / eq[j];
+ //
+ // Avoid complete loss
+ //
+ if (zInitial[j] == 1.) zInitial[j] = 0.95;
+ //
+ // Some debug printing
+ printf("Initial parton # %3d, Type %3d Energy %10.3f Phi %10.3f Length %10.3f Loss %10.3f Kick %10.3f\n",
+ j, itype, eq[j], phi, l, eloss, wjtKick[j]);
+ }
+ quenched[j] = (zInitial[j] > 0.01);
+ }
+
+//
+// Radiated partons
+//
+ zInitial[0] = 1. - TMath::Power(1. - zInitial[0], 1./Double_t(kGluons));
+ zInitial[1] = 1. - TMath::Power(1. - zInitial[1], 1./Double_t(kGluons));
+ wjtKick[0] = wjtKick[0] / TMath::Sqrt(Double_t(kGluons));
+ wjtKick[1] = wjtKick[1] / TMath::Sqrt(Double_t(kGluons));
+// this->Pylist(1);
+
+// Arrays to store particle 4-momenta to be changed
+//
+/*
+ Double_t** pNew = new Double_t* [numpart];
+ for (Int_t i = 0; i < numpart; i++) pNew[i] = new Double_t [4];
+ Int_t* kNew = new Int_t [numpart];
+*/
+
+ Double_t pNew[1000][4];
+ Int_t kNew[1000];
+ Int_t icount = 0;
+//
+// Radiation Loop
+ for (Int_t iglu = 0; iglu < kGluons; iglu++) {
+ for (Int_t isys = 0; isys < 2; isys++) {
+// Skip to next system if not quenched.
+
+
+ Double_t zHeavy = zInitial[isys];
+
+ if (!quenched[isys]) continue;
+//
+ while (1) {
+ icount = 0;
+ for (Int_t k = 0; k < 4; k++)
+ {
+ p0[isys][k] = 0.;
+ p1[isys][k] = 0.;
+ p2[isys][k] = 0.;
+ }
+// Loop over partons
+ for (Int_t i = 0; i < numpart; i++)
+ {
+ imo = fPyjets->K[2][i];
+ kst = fPyjets->K[0][i];
+ pdg = fPyjets->K[1][i];
+
+
+
+// Quarks and gluons only
+ if (pdg != 21 && TMath::Abs(pdg) > 6) continue;
+// Particles from hard scattering only
+ if (imo > 8 && imo < 1000) imo = fPyjets->K[2][imo - 1];
+ if (imo != isys + 7 && imo != 1000 + isys + 7) continue;
+
+// Skip comment lines
+ if (kst != 1 && kst != 2) continue;
+//
+// Parton kinematic
+ px = fPyjets->P[0][i];
+ py = fPyjets->P[1][i];
+ pz = fPyjets->P[2][i];
+ e = fPyjets->P[3][i];
+ m = fPyjets->P[4][i];
+ pt = TMath::Sqrt(px * px + py * py);
+ p = TMath::Sqrt(px * px + py * py + pz * pz);
+ phi = TMath::Pi() + TMath::ATan2(-py, -px);
+ theta = TMath::ATan2(pt, pz);
+
+//
+// Save 4-momentum sum for balancing
+ Int_t index = imo - 7;
+ if (index >= 1000) index -= 1000;
+
+ p0[index][0] += px;
+ p0[index][1] += py;
+ p0[index][2] += pz;
+ p0[index][3] += e;
+
+// Don't quench radiated gluons
+//
+ if (imo == 1000 + isys + 7) {
+ p1[index][0] += px;
+ p1[index][1] += py;
+ p1[index][2] += pz;
+ p1[index][3] += e;
+ continue;
+ }
+
+//
+
+ klast[index] = i;
+
+//
+// Fractional energy loss
+ Double_t z = zInitial[index];
+ if (m > 0.) z = zHeavy;
+
+ //
+ //
+ // Transform into frame in which initial parton is along z-axis
+ //
+ TVector3 v(px, py, pz);
+ v.RotateZ(-phiq[index]); v.RotateY(-thetaq[index]);
+ Double_t pxs = v.X(); Double_t pys = v.Y(); Double_t pl = v.Z();
+
+ Double_t jt = TMath::Sqrt(pxs * pxs + pys * pys);
+ Double_t mt2 = jt * jt + m * m;
+ Double_t zmax = 1.;
+ //
+ // Kinematic limit on z
+ //
+
+ if (m > 0.) {
+ zmax = 1. - m / TMath::Sqrt(m * m + jt * jt);
+ if (z > zmax) {
+ printf("We have to put z to the kinematic limit %e %e \n", z, zmax);
+ z = 0.9999 * zmax;
+ } // z > zmax
+
+ if (z < 0.01) {
+//
+// If z is too small, there is no phase space for quenching
+//
+ printf("No phase space for quenching ! %e \n", z);
+ p1[index][0] += px;
+ p1[index][1] += py;
+ p1[index][2] += pz;
+ p1[index][3] += e;
+ continue;
+ }
+ } // massive particles
+
+ //
+ // Change light-cone kinematics rel. to initial parton
+ //
+ Double_t eppzOld = e + pl;
+ Double_t empzOld = e - pl;
+
+ Double_t eppzNew = (1. - z) * eppzOld;
+ Double_t empzNew = empzOld - mt2 * z / eppzOld;
+ Double_t eNew = 0.5 * (eppzNew + empzNew);
+ Double_t plNew = 0.5 * (eppzNew - empzNew);
+
+ Double_t jtNew;
+ //
+ // if mt very small (or sometimes even < 0 for numerical reasons) set it to 0
+ Double_t mt2New = eppzNew * empzNew;
+ if (mt2New < 1.e-8) mt2New = 0.;
+
+ if (m * m > mt2New) {
+ //
+ // This should not happen
+ //
+ Fatal("Quench()", "This should never happen %e %e %e!", m, eppzNew, empzNew);
+ jtNew = 0;
+ } else {
+ jtNew = TMath::Sqrt(mt2New - m * m);
+ }
+
+
+ //
+ // Calculate new px, py
+ //
+ Double_t pxNew = jtNew / jt * pxs;
+ Double_t pyNew = jtNew / jt * pys;
+
+// Double_t dpx = pxs - pxNew;
+// Double_t dpy = pys - pyNew;
+// Double_t dpz = pl - plNew;
+// Double_t de = e - eNew;
+// Double_t dmass2 = de * de - dpx * dpx - dpy * dpy - dpz * dpz;
+// printf("New mass (1) %e %e %e %e %e %e %e \n", dmass2, jt, jtNew, pl, plNew, e, eNew);
+// printf("New mass (2) %e %e \n", pxNew, pyNew);
+ //
+ // Rotate back
+ //
+ TVector3 w(pxNew, pyNew, plNew);
+ w.RotateY(thetaq[index]); w.RotateZ(phiq[index]);
+ pxNew = w.X(); pyNew = w.Y(); plNew = w.Z();
+
+ p1[index][0] += pxNew;
+ p1[index][1] += pyNew;
+ p1[index][2] += plNew;
+ p1[index][3] += eNew;
+ //
+ // Updated 4-momentum vectors
+ //
+ pNew[icount][0] = pxNew;
+ pNew[icount][1] = pyNew;
+ pNew[icount][2] = plNew;
+ pNew[icount][3] = eNew;
+ kNew[icount] = i;
+ icount++;
+ } // parton loop
+ //
+ // Check if there was phase-space for quenching
+ //
+
+ if (icount == 0) quenched[isys] = kFALSE;
+ if (!quenched[isys]) break;
+
+ for (Int_t j = 0; j < 4; j++)
+ {
+ p2[isys][j] = p0[isys][j] - p1[isys][j];
+ }
+ p2[isys][4] = p2[isys][3] * p2[isys][3] - p2[isys][0] * p2[isys][0] - p2[isys][1] * p2[isys][1] - p2[isys][2] * p2[isys][2];
+
+ if (p2[isys][4] > 0.) {
+ p2[isys][4] = TMath::Sqrt(p2[isys][4]);
+ break;
+ } else {
+ printf("Warning negative mass squared in system %d %f ! \n", isys, zInitial[isys]);
+
+ printf("Kinematics %10.3e %10.3e %10.3e %10.3e %10.3e \n", p2[isys][0], p2[isys][1], p2[isys][2], p2[isys][3], p2[isys][4]);
+ if (p2[isys][4] < -0.01) {
+ printf("Negative mass squared ! Let's try to fix this by decreasing z\n");
+// this->Pylist(1);
+
+ } else {
+ p2[isys][4] = 0.;
+ break;
+ }
+ }
+ //
+ // jt-kick
+ //
+ /*
+ TVector3 v(p2[k][0], p2[k][1], p2[k][2]);
+ v.RotateZ(-phiq[k]);
+ v.RotateY(-thetaq[k]);
+ Double_t px = v.X(); Double_t py = v.Y(); Double_t pz = v.Z();
+ Double_t r = AliPythiaRndm::GetPythiaRandom()->Rndm();
+ Double_t jtKick = wjtKick[k] * TMath::Sqrt(-TMath::Log(r));
+ Double_t phiKick = 2. * TMath::Pi() * AliPythiaRndm::GetPythiaRandom()->Rndm();
+ px += jtKick * TMath::Cos(phiKick);
+ py += jtKick * TMath::Sin(phiKick);
+ TVector3 w(px, py, pz);
+ w.RotateY(thetaq[k]);
+ w.RotateZ(phiq[k]);
+ p2[k][0] = w.X(); p2[k][1] = w.Y(); p2[k][2] = w.Z();
+ p2[k][3] = TMath::Sqrt(p2[k][0] * p2[k][0] + p2[k][1] * p2[k][1] + p2[k][2] * p2[k][2] + p2[k][4] * p2[k][4]);
+ */
+ zHeavy *= 0.98;
+ printf("zHeavy lowered to %f\n", zHeavy);
+ if (zHeavy < 0.01) {
+ printf("No success ! \n");
+ icount = 0;
+ quenched[isys] = kFALSE;
+ break;
+ }
+ } // iteration on z
+
+// Update event record
+ for (Int_t k = 0; k < icount; k++) {
+// printf("%6d %6d %10.3e %10.3e %10.3e %10.3e\n", k, kNew[k], pNew[k][0],pNew[k][1], pNew[k][2], pNew[k][3] );
+ fPyjets->P[0][kNew[k]] = pNew[k][0];
+ fPyjets->P[1][kNew[k]] = pNew[k][1];
+ fPyjets->P[2][kNew[k]] = pNew[k][2];
+ fPyjets->P[3][kNew[k]] = pNew[k][3];
+ }
+ } // System
+ //
+ // Add the gluons
+ //
+ Int_t ish = 0;
+ for (Int_t i = 0; i < 2; i++) {
+ Int_t jmin, jmax, iGlu, iNew;
+ if (!quenched[i]) continue;
+//
+// Last parton from shower i
+ Int_t in = klast[i];
+//
+// Continue if no parton in shower i selected
+ if (in == -1) continue;
+//
+// If this is the second initial parton and it is behind the first move pointer by previous ish
+ if (i == 1 && klast[1] > klast[0]) in += ish;
+//
+// Starting index
+
+ jmin = in - 1;
+// How many additional gluons will be generated
+ ish = 1;
+ if (p2[i][4] > 0.05) ish = 2;
+//
+// Position of gluons
+ iGlu = in;
+ iNew = in + ish;
+ jmax = numpart + ish - 1;
+
+ if (fPyjets->K[0][in-1] == 1 || fPyjets->K[0][in-1] == 21 || fPyjets->K[0][in-1] == 11) {
+ jmin = in;
+ iGlu = in + 1;
+ iNew = in;
+ }
+
+ kglu[i] = iGlu;
+//
+// Shift stack
+//
+ for (Int_t j = jmax; j > jmin; j--)
+ {
+ for (Int_t k = 0; k < 5; k++) {
+ fPyjets->K[k][j] = fPyjets->K[k][j-ish];
+ fPyjets->P[k][j] = fPyjets->P[k][j-ish];
+ fPyjets->V[k][j] = fPyjets->V[k][j-ish];
+ }
+ } // end shifting
+
+ numpart += ish;
+ (fPyjets->N) += ish;
+
+ if (ish == 1) {
+ fPyjets->P[0][iGlu] = p2[i][0];
+ fPyjets->P[1][iGlu] = p2[i][1];
+ fPyjets->P[2][iGlu] = p2[i][2];
+ fPyjets->P[3][iGlu] = p2[i][3];
+ fPyjets->P[4][iGlu] = p2[i][4];
+
+ fPyjets->K[0][iGlu] = 2;
+ fPyjets->K[1][iGlu] = 21;
+ fPyjets->K[2][iGlu] = fPyjets->K[2][iNew] + 1000;
+ fPyjets->K[3][iGlu] = -1;
+ fPyjets->K[4][iGlu] = -1;
+ } else {
+ //
+ // Split gluon in rest frame.
+ //
+ Double_t bx = p2[i][0] / p2[i][3];
+ Double_t by = p2[i][1] / p2[i][3];
+ Double_t bz = p2[i][2] / p2[i][3];
+ Double_t pst = p2[i][4] / 2.;
+ //
+ // Isotropic decay ????
+ Double_t cost = 2. * gRandom->Rndm() - 1.;
+ Double_t sint = TMath::Sqrt(1. - cost * cost);
+ Double_t phi = 2. * TMath::Pi() * gRandom->Rndm();
+
+ Double_t pz1 = pst * cost;
+ Double_t pz2 = -pst * cost;
+ Double_t pt1 = pst * sint;
+ Double_t pt2 = -pst * sint;
+ Double_t px1 = pt1 * TMath::Cos(phi);
+ Double_t py1 = pt1 * TMath::Sin(phi);
+ Double_t px2 = pt2 * TMath::Cos(phi);
+ Double_t py2 = pt2 * TMath::Sin(phi);
+
+ fPyjets->P[0][iGlu] = px1;
+ fPyjets->P[1][iGlu] = py1;
+ fPyjets->P[2][iGlu] = pz1;
+ fPyjets->P[3][iGlu] = pst;
+ fPyjets->P[4][iGlu] = 0.;
+
+ fPyjets->K[0][iGlu] = 2;
+ fPyjets->K[1][iGlu] = 21;
+ fPyjets->K[2][iGlu] = fPyjets->K[2][iNew] + 1000;
+ fPyjets->K[3][iGlu] = -1;
+ fPyjets->K[4][iGlu] = -1;
+
+ fPyjets->P[0][iGlu+1] = px2;
+ fPyjets->P[1][iGlu+1] = py2;
+ fPyjets->P[2][iGlu+1] = pz2;
+ fPyjets->P[3][iGlu+1] = pst;
+ fPyjets->P[4][iGlu+1] = 0.;
+
+ fPyjets->K[0][iGlu+1] = 2;
+ fPyjets->K[1][iGlu+1] = 21;
+ fPyjets->K[2][iGlu+1] = fPyjets->K[2][iNew] + 1000;
+ fPyjets->K[3][iGlu+1] = -1;
+ fPyjets->K[4][iGlu+1] = -1;
+ SetMSTU(1,0);
+ SetMSTU(2,0);
+ //
+ // Boost back
+ //
+ Pyrobo(iGlu + 1, iGlu + 2, 0., 0., bx, by, bz);
+ }
+ }
+
+ // Check energy conservation
+ Double_t pxs = 0.;
+ Double_t pys = 0.;
+ Double_t pzs = 0.;
+ Double_t es = 14000.;
+
+ for (Int_t i = 0; i < numpart; i++)
+ {
+ kst = fPyjets->K[0][i];
+ if (kst != 1 && kst != 2) continue;
+ pxs += fPyjets->P[0][i];
+ pys += fPyjets->P[1][i];
+ pzs += fPyjets->P[2][i];
+ es -= fPyjets->P[3][i];
+ }
+ if (TMath::Abs(pxs) > 1.e-2 ||
+ TMath::Abs(pys) > 1.e-2 ||
+ TMath::Abs(pzs) > 1.e-1) {
+ printf("%e %e %e %e\n", pxs, pys, pzs, es);
+ this->Pylist(1);
+ Fatal("Quench()", "4-Momentum non-conservation");
+ }
+// this->Pylist(1);
+
+ } // end quenching loop
+// Clean-up
+ for (Int_t i = 0; i < numpart; i++)
+ {
+ imo = fPyjets->K[2][i];
+ if (imo > 1000) fPyjets->K[2][i] = fPyjets->K[2][i] % 1000;
+ }
+
+
+
+// delete[] kNew;
+// delete[] pNew;
+
+} // end quench