Public Member Functions | Private Member Functions | Private Attributes | List of all members
genie::AhrensDMELPXSec Class Reference

Differential cross section for DM+N elastic scattering.
Is a concrete implementation of the XSecAlgorithmI interface.
. More...

#include <AhrensDMELPXSec.h>

Inheritance diagram for genie::AhrensDMELPXSec:
genie::XSecAlgorithmI genie::Algorithm

Public Member Functions

 AhrensDMELPXSec ()
 
 AhrensDMELPXSec (string config)
 
virtual ~AhrensDMELPXSec ()
 
double XSec (const Interaction *i, KinePhaseSpace_t k) const
 Compute the cross section for the input interaction. More...
 
double Integral (const Interaction *i) const
 
bool ValidProcess (const Interaction *i) const
 Can this cross section algorithm handle the input process? More...
 
void Configure (const Registry &config)
 
void Configure (string param_set)
 
- Public Member Functions inherited from genie::XSecAlgorithmI
virtual ~XSecAlgorithmI ()
 
virtual bool ValidKinematics (const Interaction *i) const
 Is the input kinematical point a physically allowed one? More...
 
- Public Member Functions inherited from genie::Algorithm
virtual ~Algorithm ()
 
virtual void FindConfig (void)
 
virtual const RegistryGetConfig (void) const
 
RegistryGetOwnedConfig (void)
 
virtual const AlgIdId (void) const
 Get algorithm ID. More...
 
virtual AlgStatus_t GetStatus (void) const
 Get algorithm status. More...
 
virtual bool AllowReconfig (void) const
 
virtual AlgCmp_t Compare (const Algorithm *alg) const
 Compare with input algorithm. More...
 
virtual void SetId (const AlgId &id)
 Set algorithm ID. More...
 
virtual void SetId (string name, string config)
 
const AlgorithmSubAlg (const RgKey &registry_key) const
 
void AdoptConfig (void)
 
void AdoptSubstructure (void)
 
virtual void Print (ostream &stream) const
 Print algorithm info. More...
 

Private Member Functions

void LoadConfig (void)
 

Private Attributes

const XSecIntegratorIfXSecIntegrator
 
double fQchiV
 
double fQchiA
 
double fQchiS
 
double fQuV
 
double fQuA
 
double fQdV
 
double fQdA
 
double fQsV
 
double fQsA
 
double fMa2
 
double fMv2
 
double fMp2
 
double fMpi2
 
double fMeta2
 
double fMuP
 
double fMuN
 
double fDelu
 
double fDeld
 
double fDels
 
double fDeluP
 
double fDeldP
 
double fDelsP
 
int fVelMode
 
double fMedMass
 
double fgZp
 

Additional Inherited Members

- Static Public Member Functions inherited from genie::Algorithm
static string BuildParamVectKey (const std::string &comm_name, unsigned int i)
 
static string BuildParamVectSizeKey (const std::string &comm_name)
 
- Protected Member Functions inherited from genie::XSecAlgorithmI
 XSecAlgorithmI ()
 
 XSecAlgorithmI (string name)
 
 XSecAlgorithmI (string name, string config)
 
- Protected Member Functions inherited from genie::Algorithm
 Algorithm ()
 
 Algorithm (string name)
 
 Algorithm (string name, string config)
 
void Initialize (void)
 
void DeleteConfig (void)
 
void DeleteSubstructure (void)
 
RegistryExtractLocalConfig (const Registry &in) const
 
RegistryExtractLowerConfig (const Registry &in, const string &alg_key) const
 Split an incoming configuration Registry into a block valid for the sub-algo identified by alg_key. More...
 
template<class T >
bool GetParam (const RgKey &name, T &p, bool is_top_call=true) const
 
template<class T >
bool GetParamDef (const RgKey &name, T &p, const T &def) const
 
template<class T >
int GetParamVect (const std::string &comm_name, std::vector< T > &v, bool is_top_call=true) const
 Handle to load vectors of parameters. More...
 
int GetParamVectKeys (const std::string &comm_name, std::vector< RgKey > &k, bool is_top_call=true) const
 
int AddTopRegistry (Registry *rp, bool owns=true)
 add registry with top priority, also update ownership More...
 
int AddLowRegistry (Registry *rp, bool owns=true)
 add registry with lowest priority, also update ownership More...
 
int MergeTopRegistry (const Registry &r)
 
int AddTopRegisties (const vector< Registry * > &rs, bool owns=false)
 Add registries with top priority, also udated Ownerships. More...
 
- Protected Attributes inherited from genie::Algorithm
bool fAllowReconfig
 
bool fOwnsSubstruc
 true if it owns its substructure (sub-algs,...) More...
 
AlgId fID
 algorithm name and configuration set More...
 
vector< Registry * > fConfVect
 
vector< boolfOwnerships
 ownership for every registry in fConfVect More...
 
AlgStatus_t fStatus
 algorithm execution status More...
 
AlgMapfOwnedSubAlgMp
 local pool for owned sub-algs (taken out of the factory pool) More...
 

Detailed Description

Differential cross section for DM+N elastic scattering.
Is a concrete implementation of the XSecAlgorithmI interface.
.

R.E.Hendrick and L.Li, Phys.Rev.D 19:779 (1979) L.A.Ahrens et al., Phys.Rev.D 35:785 (1987)

Author
Joshua Berger <jberger physics.wisc.edu> University of Wisconsin-Madison

Costas Andreopoulos <constantinos.andreopoulos cern.ch> University of Liverpool & STFC Rutherford Appleton Laboratory

September 4, 2017

Copyright (c) 2003-2020, The GENIE Collaboration For the full text of the license visit http://copyright.genie-mc.org

Definition at line 35 of file AhrensDMELPXSec.h.

Constructor & Destructor Documentation

AhrensDMELPXSec::AhrensDMELPXSec ( )

Definition at line 37 of file AhrensDMELPXSec.cxx.

37  :
38 XSecAlgorithmI("genie::AhrensDMELPXSec")
39 {
40 
41 }
AhrensDMELPXSec::AhrensDMELPXSec ( string  config)

Definition at line 43 of file AhrensDMELPXSec.cxx.

43  :
44 XSecAlgorithmI("genie::AhrensDMELPXSec", config)
45 {
46 
47 }
static Config * config
Definition: config.cpp:1054
AhrensDMELPXSec::~AhrensDMELPXSec ( )
virtual

Definition at line 49 of file AhrensDMELPXSec.cxx.

50 {
51 
52 }

Member Function Documentation

void AhrensDMELPXSec::Configure ( const Registry config)
virtual

Configure the algorithm with an external registry The registry is merged with the top level registry if it is owned, Otherwise a copy of it is added with the highest priority

Reimplemented from genie::Algorithm.

Definition at line 204 of file AhrensDMELPXSec.cxx.

205 {
206  Algorithm::Configure(config);
207  this->LoadConfig();
208 }
virtual void Configure(const Registry &config)
Definition: Algorithm.cxx:62
void AhrensDMELPXSec::Configure ( string  config)
virtual

Configure the algorithm from the AlgoConfigPool based on param_set string given in input An algorithm contains a vector of registries coming from different xml configuration files, which are loaded according a very precise prioriy This methods will load a number registries in order of priority: 1) "Tunable" parameter set from CommonParametes. This is loaded with the highest prioriry and it is designed to be used for tuning procedure Usage not expected from the user. 2) For every string defined in "CommonParame" the corresponding parameter set will be loaded from CommonParameter.xml 3) parameter set specified by the config string and defined in the xml file of the algorithm 4) if config is not "Default" also the Default parameter set from the same xml file will be loaded Effectively this avoids the repetion of a parameter when it is not changed in the requested configuration

Reimplemented from genie::Algorithm.

Definition at line 210 of file AhrensDMELPXSec.cxx.

211 {
213  this->LoadConfig();
214 }
static Config * config
Definition: config.cpp:1054
virtual void Configure(const Registry &config)
Definition: Algorithm.cxx:62
double AhrensDMELPXSec::Integral ( const Interaction i) const
virtual

Integrate the model over the kinematic phase space available to the input interaction (kinematical cuts can be included)

Implements genie::XSecAlgorithmI.

Definition at line 192 of file AhrensDMELPXSec.cxx.

193 {
194  double xsec = fXSecIntegrator->Integrate(this,interaction);
195  return xsec;
196 }
const XSecIntegratorI * fXSecIntegrator
virtual double Integrate(const XSecAlgorithmI *model, const Interaction *interaction) const =0
void AhrensDMELPXSec::LoadConfig ( void  )
private

Definition at line 216 of file AhrensDMELPXSec.cxx.

217 {
218  // dark matter couplings to mediator
219  double QchiL, QchiR;
220  this->GetParam( "DarkLeftCharge", QchiL ) ;
221  this->GetParam( "DarkRightCharge", QchiR ) ;
222  this->GetParam( "DarkScalarCharge", fQchiS ) ;
223  fQchiV = 0.5*(QchiL + QchiR);
224  fQchiA = 0.5*(- QchiL + QchiR);
225 
226  // quark couplings to mediator
227  double QuL, QuR, QdL, QdR, QsL, QsR;
228  this->GetParam( "UpLeftCharge", QuL ) ;
229  this->GetParam( "UpRightCharge", QuR ) ;
230  this->GetParam( "DownLeftCharge", QdL ) ;
231  this->GetParam( "DownRightCharge", QdR ) ;
232  this->GetParam( "StrangeLeftCharge", QsL ) ;
233  this->GetParam( "StrangeRightCharge", QsR ) ;
234  fQuV = 0.5*(QuL + QuR);
235  fQuA = 0.5*(- QuL + QuR);
236  fQdV = 0.5*(QdL + QdR);
237  fQdA = 0.5*(- QdL + QdR);
238  fQsV = 0.5*(QsL + QsR);
239  fQsA = 0.5*(- QsL + QsR);
240 
241  // axial and vector masses
242  double ma, mv, mp, mpi, meta ;
243  this->GetParam( "QEL-Ma", ma ) ;
244  this->GetParam( "QEL-Mv", mv ) ;
245  this->GetParam( "DMEL-Mp", mp ) ;
246  this->GetParam( "DMEL-Mpi", mpi ) ;
247  this->GetParam( "DMEL-Meta", meta ) ;
248  fMa2 = TMath::Power(ma,2);
249  fMv2 = TMath::Power(mv,2);
250  fMp2 = TMath::Power(mp,2);
251  fMpi2 = TMath::Power(mpi,2);
252  fMeta2 = TMath::Power(meta,2);
253 
254  // anomalous magnetic moments
255  this->GetParam( "AnomMagnMoment-P", fMuP ) ;
256  this->GetParam( "AnomMagnMoment-N", fMuN ) ;
257 
258  // Axial-vector spin charge
259  // Since we have a more general axial dependence,
260  // we need a more complex treatment than the usual model
261  this->GetParam( "AxialVectorSpin-u", fDelu );
262  this->GetParam( "AxialVectorSpin-d", fDeld );
263  this->GetParam( "AxialVectorSpin-s", fDels );
264 
265  // velocity dependence of interaction
266  this->GetParamDef("velocity-mode", fVelMode, 0 );
267 
268  // mediator coupling
269  this->GetParam("ZpCoupling", fgZp ) ;
270 
271  // mediator mass
273 
274  // load XSec Integrator
276  dynamic_cast<const XSecIntegratorI *> (this->SubAlg("XSec-Integrator"));
277  assert(fXSecIntegrator);
278 }
Cross Section Integrator Interface.
const int kPdgMediator
Definition: PDGCodes.h:220
const XSecIntegratorI * fXSecIntegrator
static PDGLibrary * Instance(void)
Definition: PDGLibrary.cxx:57
TParticlePDG * Find(int pdgc, bool must_exist=true)
Definition: PDGLibrary.cxx:75
bool GetParamDef(const RgKey &name, T &p, const T &def) const
bool GetParam(const RgKey &name, T &p, bool is_top_call=true) const
const Algorithm * SubAlg(const RgKey &registry_key) const
Definition: Algorithm.cxx:345
bool AhrensDMELPXSec::ValidProcess ( const Interaction i) const
virtual

Can this cross section algorithm handle the input process?

Implements genie::XSecAlgorithmI.

Definition at line 198 of file AhrensDMELPXSec.cxx.

199 {
200  if(interaction->TestBit(kISkipProcessChk)) return true;
201  return true;
202 }
const UInt_t kISkipProcessChk
if set, skip process validity checks
Definition: Interaction.h:47
double AhrensDMELPXSec::XSec ( const Interaction i,
KinePhaseSpace_t  k 
) const
virtual

Compute the cross section for the input interaction.

Implements genie::XSecAlgorithmI.

Definition at line 54 of file AhrensDMELPXSec.cxx.

56 {
57  if(! this -> ValidProcess (interaction) ) return 0.;
58  if(! this -> ValidKinematics (interaction) ) return 0.;
59 
60  const InitialState & init_state = interaction -> InitState();
61  const Kinematics & kinematics = interaction -> Kine();
62  const Target & target = init_state.Tgt();
63 
64  LOG("AhrensDMEL", pDEBUG) << "Using v^" << fVelMode << " dependence";
65 
66  double E = init_state.ProbeE(kRfHitNucRest);
67  double ml = init_state.GetProbeP4(kRfHitNucRest)->M();
68  double Q2 = kinematics.Q2();
69  double M = target.HitNucMass();
70  double M2 = TMath::Power(M, 2.);
71  double E2 = TMath::Power(E, 2.);
72  double ml2 = TMath::Power(ml,2.);
73  LOG("AhrensDMEL", pNOTICE) << "Form factor masses are " << fMv2 << ", " << fMa2;
74  double qmv2 = TMath::Power(1 + Q2/fMv2, 2);
75  double qma2 = TMath::Power(1 + Q2/fMa2, 2);
76 
77  //-- handle terms changing sign for antineutrinos and isospin rotations
78  int nusign = 1;
79  int nucsign = 1;
80  int nupdgc = init_state.ProbePdg();
81  int nucpdgc = target.HitNucPdg();
82  if( pdg::IsAntiDarkMatter(nupdgc) ) nusign = -1;
83  if( pdg::IsNeutron(nucpdgc) ) nucsign = -1;
84 
85  LOG("AhrensDMEL", pNOTICE) << "Calculating for nuclear sign " << nucsign;
86 
87  //-- compute up quark form factor terms
88  double Geu = fQuV * (1.5 + nucsign*0.5) / qmv2;
89  double Gmu = fQuV * ((1.5 + nucsign*0.5) * fMuP + (1.5 - nucsign*0.5) * fMuN) / qmv2;
90  double FAu = fQuA * (nucsign > 0 ? fDelu : fDeld) / qma2;
91 
92  //-- compute down quark form factor terms
93  double Ged = fQdV * (1.5 - nucsign*0.5) / qmv2;
94  double Gmd = fQdV * ((1.5 - nucsign*0.5) * fMuP + (1.5 + nucsign*0.5) * fMuN) / qmv2;
95  double FAd = fQdA * (nucsign > 0 ? fDeld : fDelu) / qma2;
96 
97  //-- compute the induced pseudoscalar form factors
98  double pole3 = 4.0*M2 / (Q2 + fMpi2);
99  double pole0 = 4.0*M2 / (Q2 + fMeta2);
100  double FPu = 0.5 * (pole3 * (FAu - FAd) + pole0 * (FAu + FAd));
101  double FPd = 0.5 * (- pole3 * (FAu - FAd) + pole0 * (FAu + FAd));
102 
103  //-- compute strange quark form factor terms
104  double Ges = 0.0;
105  double Gms = 0.0;
106  double FAs = fQsA * fDels / qma2;
107  double FPs = 0.0; // fQsA * 2.0 * M2 * fDels / qmp2 / fMpi2;
108 
109  //-- compute form factors
110  double Ge = Geu + Ged + Ges;
111  double Gm = Gmu + Gmd + Gms;
112  double FA = FAu + FAd + FAs;
113  double FP = FPu + FPd + FPs;
114  double tau = 0.25 * Q2/M2;
115  double F1 = (Ge + tau * Gm) / (1.0 + tau);
116  double F2 = (Gm - Ge) / (1.0 + tau);
117  double F12 = TMath::Power(F1,2);
118  double F22 = TMath::Power(F2,2);
119  double FA2 = TMath::Power(FA,2);
120 
121  //-- compute the free nucleon cross section
122  double xsec = 0.;
123  double del = ml2 / M2;
124  double AT_F1F1 = 0.;
125  double AT_F2F2 = 0.;
126  double AT_FAFA = 0.;
127  double AT_F1F2 = 0.;
128  double AL = 0.;
129  double B = 0.;
130  double C = 0.;
131  if (fVelMode == 0) {
132  double QchiV2 = TMath::Power(fQchiV,2);
133  double QchiA2 = TMath::Power(fQchiA,2);
134  C = (QchiA2 + QchiV2) * (F12 + F22 * tau + FA2);
135  B = 8. * fQchiA * fQchiV * tau * FA * (F1 + F2);
136  AL = 16. * QchiA2 * del * TMath::Power(tau*(FA - 2.*FP*tau),2);
137  AT_F1F1 = QchiA2*(tau-1.)*(del+tau) + QchiV2*tau*(-del+tau-1);
138  AT_F2F2 = -tau*(QchiA2*(tau-1.)*(del+tau) + QchiV2*(del + (tau-1.)*tau));
139  AT_FAFA = (1.+tau)*(QchiA2*(del+tau) + QchiV2*(tau-del));
140  AT_F1F2 = 2.*tau*(2.*QchiA2*(del+tau) - QchiV2*(del-2.*tau));
141  }
142  else if (fVelMode == 2) {
143  double QchiS2 = TMath::Power(fQchiS,2);
144  C = QchiS2 * (F12 + F22 * tau + FA2);
145  AT_F1F1 = -QchiS2 * tau * (del + tau);
146  AT_F2F2 = AT_F1F1;
147  AT_FAFA = -QchiS2 * (tau + 1.) * (del + tau);
148  AT_F1F2 = 2.*AT_F1F1;
149  }
150  double smu = E/M - tau;
151  double MZ2 = TMath::Power(fMedMass,2);
152  double lon = TMath::Power(M2 / MZ2 + 0.25/tau,2);
153  LOG("AhrensDMEL", pDEBUG)
154  << "Using a mediator mass of " << fMedMass;
155  // double fd = 8*ml2*M2*tau*(2*M2*tau+MZ2) / (MZ2*MZ2*E2);
156  double gZp = fgZp;
157  double gZp4 = TMath::Power(gZp,4);
158  double prop = 1. / (Q2 + MZ2);
159  double prop2 = TMath::Power(prop,2);
160  double xsec0 = gZp4 * M2 * prop2 / (4. * kPi * (E2 - ml2));
161  xsec = xsec0 * (AL * lon + AT_F1F1 * F12 + AT_F2F2 * F22 + AT_FAFA * FA2 + AT_F1F2 * F1 * F2 + nusign * B * smu + C * smu * smu);
162 
163  LOG("AhrensDMEL", pDEBUG)
164  << "dXSec[vN,El]/dQ2 [FreeN](Ev = "<< E<< ", Q2 = "<< Q2 << ") = "<< xsec;
165 
166  //-- The algorithm computes dxsec/dQ2
167  // Check whether variable tranformation is needed
168  if(kps!=kPSQ2fE) {
170  xsec *= J;
171  }
172 
173  //-- if requested return the free nucleon xsec even for input nuclear tgt
174  if( interaction->TestBit(kIAssumeFreeNucleon) ) return xsec;
175 
176  //-- compute nuclear suppression factor
177  // (R(Q2) is adapted from NeuGEN - see comments therein)
178  double R = nuclear::NuclQELXSecSuppression("Default", 0.5, interaction);
179 
180  //-- number of scattering centers in the target
181  int NNucl = (pdg::IsProton(nucpdgc)) ? target.Z() : target.N();
182 
183  LOG("AhrensDMEL", pDEBUG)
184  << "Nuclear suppression factor R(Q2) = " << R << ", NNucl = " << NNucl;
185 
186  //-- compute nuclear cross section
187  xsec *= (R*NNucl);
188 
189  return xsec;
190 }
#define F2(x, y, z)
Definition: md5.c:176
double J(double q0, double q3, double Enu, double ml)
Definition: MECUtils.cxx:147
#define F1(x, y, z)
Definition: md5.c:175
double Q2(const Interaction *const i)
Definition: KineUtils.cxx:1064
int HitNucPdg(void) const
Definition: Target.cxx:304
double HitNucMass(void) const
Definition: Target.cxx:233
bool ValidProcess(const Interaction *i) const
Can this cross section algorithm handle the input process?
Generated/set kinematical variables for an event.
Definition: Kinematics.h:39
bool IsNeutron(int pdgc)
Definition: PDGUtils.cxx:338
virtual bool ValidKinematics(const Interaction *i) const
Is the input kinematical point a physically allowed one?
bool IsProton(int pdgc)
Definition: PDGUtils.cxx:333
#define LOG(stream, priority)
A macro that returns the requested log4cpp::Category appending a string (using the FILE...
Definition: Messenger.h:96
bool IsAntiDarkMatter(int pdgc)
Definition: PDGUtils.cxx:130
A Neutrino Interaction Target. Is a transparent encapsulation of quite different physical systems suc...
Definition: Target.h:40
int ProbePdg(void) const
Definition: InitialState.h:64
int Z(void) const
Definition: Target.h:68
int N(void) const
Definition: Target.h:69
const UInt_t kIAssumeFreeNucleon
Definition: Interaction.h:49
Definition: 018_def.c:13
double Jacobian(const Interaction *const i, KinePhaseSpace_t f, KinePhaseSpace_t t)
Definition: KineUtils.cxx:130
double Q2(bool selected=false) const
Definition: Kinematics.cxx:125
#define pNOTICE
Definition: Messenger.h:61
const Target & Tgt(void) const
Definition: InitialState.h:66
double ProbeE(RefFrame_t rf) const
static const double kPi
Definition: Constants.h:37
TLorentzVector * GetProbeP4(RefFrame_t rf=kRfHitNucRest) const
double NuclQELXSecSuppression(string kftable, double pmax, const Interaction *in)
Initial State information.
Definition: InitialState.h:48
#define pDEBUG
Definition: Messenger.h:63

Member Data Documentation

double genie::AhrensDMELPXSec::fDeld
private

Definition at line 74 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fDeldP
private

Definition at line 77 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fDels
private

Definition at line 75 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fDelsP
private

Definition at line 78 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fDelu
private

Definition at line 73 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fDeluP
private

Definition at line 76 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fgZp
private

Definition at line 81 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fMa2
private

Definition at line 66 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fMedMass
private

Definition at line 80 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fMeta2
private

Definition at line 70 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fMp2
private

Definition at line 68 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fMpi2
private

Definition at line 69 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fMuN
private

Definition at line 72 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fMuP
private

Definition at line 71 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fMv2
private

Definition at line 67 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQchiA
private

Definition at line 58 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQchiS
private

Definition at line 59 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQchiV
private

Definition at line 57 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQdA
private

Definition at line 63 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQdV
private

Definition at line 62 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQsA
private

Definition at line 65 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQsV
private

Definition at line 64 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQuA
private

Definition at line 61 of file AhrensDMELPXSec.h.

double genie::AhrensDMELPXSec::fQuV
private

Definition at line 60 of file AhrensDMELPXSec.h.

int genie::AhrensDMELPXSec::fVelMode
private

Definition at line 79 of file AhrensDMELPXSec.h.

const XSecIntegratorI* genie::AhrensDMELPXSec::fXSecIntegrator
private

Definition at line 55 of file AhrensDMELPXSec.h.


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