PSD Class Reference

Phase Space Density class. More...

#include <PSD.h>

Inheritance diagram for PSD:

Inheritance graph
[legend]
Collaboration diagram for PSD:

Collaboration graph
[legend]

List of all members.

Public Member Functions

 PSD ()
 Matrix for split method.
 PSD (ParamStructure::PSD parameters, Grid &grid)
 Constructor.
 PSD (ParamStructure::PSD parameters, Grid &grid, PSD &otherPSD, Grid &otherPSD_grid, ParamStructure::Interpolation constantsInterpolation)
 PSD (ParamStructure::PSD parameters, Grid &grid, BoundaryCondition L_UpperBoundaryCondition)
 Constructor.
 ~PSD ()
 Destructor.
void Initialize (ParamStructure::PSD parameters, Grid &grid, Matrix2D< double > L_UpperBoundaryCondition=Matrix2D< double >())
 Initializing: storing parameters, loading initial values, making boundary conditions, initializing output parameters Simply, it is a creation of the object.
void LoadInitialValue (ParamStructure::PSD parameters, Grid &grid, Matrix2D< double > L_UpperBoundaryCondition=Matrix2D< double >())
 Loading initial values - from a file or other sources.
void Interpolate (PSD &otherPSD, ParamStructure::Interpolation interpolationParameters, Grid &oldGrid, Grid &newGrid, Matrix2D< double > newGrid_pc_lowerBoundaryCondition, Matrix2D< double > newGrid_pc_upperBoundaryCondition)
 Interpolation function.
void Load_initial_f (GridElement &L, GridElement &pc, GridElement &alpha, double tau, double Kp, double min_psd=1.e-99, string J_L7_function="J_L7", double fb_out=1, double fb_in=0)
 Calculate initial PSD from steady state.
void Load_initial_f (GridElement &L, GridElement &pc, GridElement &alpha, double tau, double Kp, Matrix2D< double > L_UpperBoundaryCondition, double min_psd=1.e-99, double fb_out=1, double fb_in=0)
 Calculate initial PSD from steady state using boundary conditions.
void Load_initial_f_2d (GridElement &L, GridElement &pc, GridElement &alpha, const char *filename)
 Load initial PSD from 2d-file (for 2d calculations).
void Load_initial_f_file (GridElement &L, GridElement &pc, GridElement &alpha, const char *filename, bool with_grid)
 Load initial PSD from file.
void DiffusionMixTermExplicit (double dt, double Lpp, DiffusionCoefficient &Dpca, DiffusionCoefficient &DpcaLpp, GridElement &L, GridElement &pc, GridElement &alpha, Matrix3D< double > Jacobian, Matrix2D< double > pc_lowerBoundaryCondition, Matrix2D< double > pc_upperBoundaryCondition, Matrix2D< double > alpha_lowerBoundaryCondition, Matrix2D< double > alpha_upperBoundaryCondition, string pc_lowerBoundaryCondition_calculationType, string pc_upperBoundaryCondition_calculationType, string alpha_lowerBoundaryCondition_calculationType, string alpha_upperBoundaryCondition_calculationType)
 Mixed terms calculation by explicit method.
void Diffusion_alpha (double dt, double Lpp, DiffusionCoefficient &Daa, DiffusionCoefficient &DaaLpp, GridElement &L, GridElement &pc, GridElement &alpha, Matrix3D< double > Jacobian, Matrix2D< double > alpha_lowerBoundaryCondition, Matrix2D< double > alpha_upperBoundaryCondition, string alpha_lowerBoundaryCondition_calculationType, string alpha_upperBoundaryCondition_calculationType)
 Pitch angle diffusion calculation function.
void Diffusion_pc (double dt, double Lpp, DiffusionCoefficient &Dpcpc, DiffusionCoefficient &DpcpcLpp, GridElement &L, GridElement &pc, GridElement &alpha, Matrix3D< double > Jacobian, Matrix2D< double > pc_lowerBoundaryCondition, Matrix2D< double > pc_upperBoundaryCondition, string pc_lowerBoundaryCondition_calculationType, string pc_upperBoundaryCondition_calculationType)
 Energy diffusion calculation function.
void Diffusion_L (double dt, double Lpp, DiffusionCoefficient &DLL, GridElement &L, GridElement &pc, GridElement &alpha, Matrix3D< double > Jacobian, Matrix2D< double > lowerBoundaryCondition, Matrix2D< double > upperBoundaryCondition, string lowerBoundaryCondition_calculationType, string upperBoundaryCondition_calculationType, double tau, double tauLpp)
 Radial diffusion calculation function.
void Diffusion_pc_alpha (double dt, double Lpp, DiffusionCoefficient &Dpcpc, DiffusionCoefficient &DpcpcLpp, DiffusionCoefficient &Daa, DiffusionCoefficient &DaaLpp, DiffusionCoefficient &Dpca, DiffusionCoefficient &DpcaLpp, GridElement &L, GridElement &pc, GridElement &alpha, Matrix3D< double > Jacobian, Matrix2D< double > pc_lowerBoundaryCondition, Matrix2D< double > pc_upperBoundaryCondition, Matrix2D< double > alpha_lowerBoundaryCondition, Matrix2D< double > alpha_upperBoundaryCondition, string pc_lowerBoundaryCondition_calculationType, string pc_upperBoundaryCondition_calculationType, string alpha_lowerBoundaryCondition_calculationType, string alpha_upperBoundaryCondition_calculationType)
 Radial diffusion calculation function.
void SourcesAndLosses (GridElement &L, GridElement &pc, GridElement &alpha, Matrix3D< double > &SL, double dt, double Lpp, double tau, double tauLpp)
 Sources and losses term from the FP eq.
void Output_without_grid (double time)
 PSD output.

Public Attributes

ParamStructure::PSD PSD_parameters
ofstream * output_without_grid_file


Detailed Description

Phase Space Density class.

Do diffusions and store the result in parent class Matrix3D. Do all possible operations with PSD (like output, loading, etc).

Definition at line 33 of file PSD.h.


Constructor & Destructor Documentation

PSD::PSD (  )  [inline]

Matrix for split method.

Matrix for radial diffusion. 2D matrix (for each pc and alpha) of 3-diagonal matrixes (for 1d radial diffusion problems). Default constructor - does nothing., mark initialized = false, means memory for arrays of the class was not allocated and the calculations, which should b done before using (if any) were not made.

Definition at line 47 of file PSD.h.

PSD::PSD ( ParamStructure::PSD  parameters,
Grid grid 
)

Constructor.

Creates grid, initialize parent class Matrix3D and run it's own Initialization.

We usually can use an empty constructor, like PSD(), and then do everything we need by functions, like PSD::AllocateMemory(), PSD::Initialize() etc, but sometimes we have to completely define an object right in the moment of the creation (like in stacks) and also it is shorter to use one line of code instead of 3, so we need more complicated constructors. Sometimes we can NOT define an object in the moment of construction so, we have to use an empty constructor and define the rest by functions (if we don't know everything we need for that, but want to create an object).

So, to have both options, we do not write initialization of objects (construction of objects, whatever) in the constructors. The code has functions AllocateMemory, Initialize etc, which are called from constructors. And also can be called separately. We can create an abject by calling constructor with parameters, which call additional initialization functions, or create an object by calling empty constructor and then all initialization functions.

Parameters:
parameters - PSD parameters structure
&grid - grid, calculated somewhere

Definition at line 51 of file PSD.cpp.

References Initialize().

Here is the call graph for this function:

PSD::PSD ( ParamStructure::PSD  parameters,
Grid grid,
PSD otherPSD,
Grid otherPSD_grid,
ParamStructure::Interpolation  constantsInterpolation 
)

PSD::PSD ( ParamStructure::PSD  parameters,
Grid grid,
BoundaryCondition  L_UpperBoundaryCondition 
)

Constructor.

Creats grid, initialize creats parent class Matrix3D and run it's own Initialization.

Parameters:
parameters - PSD parameters structure
&grid - grid, calculated somewhere
&L_UpperBoundaryCondition - upper boundary for steady state calculation

Definition at line 62 of file PSD.cpp.

References ParamStructure::PSD::initial_PSD_Type, Initialize(), BoundaryCondition::initialType, and Matrix3D< T >::xSlice().

Here is the call graph for this function:

PSD::~PSD (  ) 

Destructor.

Definition at line 31 of file PSD.cpp.


Member Function Documentation

void PSD::Diffusion_alpha ( double  dt,
double  Lpp,
DiffusionCoefficient Daa,
DiffusionCoefficient DaaLpp,
GridElement L,
GridElement pc,
GridElement alpha,
Matrix3D< double >  Jacobian,
Matrix2D< double >  alpha_lowerBoundaryCondition,
Matrix2D< double >  alpha_upperBoundaryCondition,
string  alpha_lowerBoundaryCondition_calculationType,
string  alpha_upperBoundaryCondition_calculationType 
)

Pitch angle diffusion calculation function.

Takes diffusion coefficients, boundary conditions and grid elements as input. It calculates model matrix by MakeModelMatrix_3D for 3D problem: A_3D * PSD_3D(t+1) = B_3D * PSD_3D(t) + C_3D then splits it for 1D problems: A * PSD_1D(t+1) = B * PSD_1D(t) + C and solve by tridiag method.

Parameters:
dt - time step
Lpp - plasma pause location
&Daa - L diffusion coefficient
&DaaLpp - L diffusion coefficient
&L - grid element L
&pc - grid elelent pc
&alpha - grid element alpha
&Jacobian - jacobian
&alpha_lowerBoundaryCondition - lower boundary condition
&alpha_upperBoundaryCondition - upper boundary condition
&alpha_lowerBoundaryCondition_calculationType - lower boundary condition type (on value/on derivative)
&alpha_upperBoundaryCondition_calculationType - upper boundary condition type (on value/on derivative)

Definition at line 323 of file PSD.cpp.

References MakeModelMatrix_3D(), GridElement::size, and tridag().

Referenced by main().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Diffusion_L ( double  dt,
double  Lpp,
DiffusionCoefficient DLL,
GridElement L,
GridElement pc,
GridElement alpha,
Matrix3D< double >  Jacobian,
Matrix2D< double >  L_lowerBoundaryCondition,
Matrix2D< double >  L_upperBoundaryCondition,
string  L_lowerBoundaryCondition_calculationType,
string  L_upperBoundaryCondition_calculationType,
double  tau,
double  tauLpp 
)

Radial diffusion calculation function.

Takes diffusion coefficients, boundary conditions and grid elements as parameters. It caltulates model matrix by makeMatrix and then solve it by SolveMatrix method.

Parameters:
dt - time step
Lpp - plasma pause location
&DLL - L diffusion coefficient
&L - grid element L
&pc - grid elelent pc
&alpha - grid element alpha
&Jacobian - jacobian
&L_lowerBoundaryCondition - lower boundary condition on L
&L_upperBoundaryCondition - upper boundary condition on L
&L_lowerBoundaryCondition_calculationType - lower boundary condition on L calculation type
&L_upperBoundaryCondition_calculationType - upper boundary condition on L calculation type
tau - life time upper location of the plasma pause
tauLpp - life time lower location of the plasma pause

Definition at line 594 of file PSD.cpp.

References MakeModelMatrix_3D(), GridElement::size, and tridag().

Referenced by main().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Diffusion_pc ( double  dt,
double  Lpp,
DiffusionCoefficient Dpcpc,
DiffusionCoefficient DpcpcLpp,
GridElement L,
GridElement pc,
GridElement alpha,
Matrix3D< double >  Jacobian,
Matrix2D< double >  pc_lowerBoundaryCondition,
Matrix2D< double >  pc_upperBoundaryCondition,
string  pc_lowerBoundaryCondition_calculationType,
string  pc_upperBoundaryCondition_calculationType 
)

Energy diffusion calculation function.

Takes diffusion coefficients, boundary conditions and grid elements as input. It calculates model matrix by MakeModelMatrix_3D for 3D problem: A_3D * PSD_3D(t+1) = B_3D * PSD_3D(t) + C_3D then splits it for 1D problems: A * PSD_1D(t+1) = B * PSD_1D(t) + C and solve by tridiag method.

Parameters:
dt - time step
Lpp - plasma pause location
&Dpcpc - L diffusion coefficient
&DpcpcLpp - L diffusion coefficient
&L - grid element L
&pc - grid elelent pc
&alpha - grid element alpha
&Jacobian - jacobian
&pc_lowerBoundaryCondition - lower boundary condition
&pc_upperBoundaryCondition - upper boundary condition
&pc_lowerBoundaryCondition_calculationType - lower boundary condition type (on value/on derivative)
&pc_upperBoundaryCondition_calculationType - upper boundary condition type (on value/on derivative)

Definition at line 458 of file PSD.cpp.

References MakeModelMatrix_3D(), GridElement::size, and tridag().

Referenced by main().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Diffusion_pc_alpha ( double  dt,
double  Lpp,
DiffusionCoefficient Dpcpc,
DiffusionCoefficient DpcpcLpp,
DiffusionCoefficient Daa,
DiffusionCoefficient DaaLpp,
DiffusionCoefficient Dpca,
DiffusionCoefficient DpcaLpp,
GridElement L,
GridElement pc,
GridElement alpha,
Matrix3D< double >  Jacobian,
Matrix2D< double >  pc_lowerBoundaryCondition,
Matrix2D< double >  pc_upperBoundaryCondition,
Matrix2D< double >  alpha_lowerBoundaryCondition,
Matrix2D< double >  alpha_upperBoundaryCondition,
string  pc_lowerBoundaryCondition_calculationType,
string  pc_upperBoundaryCondition_calculationType,
string  alpha_lowerBoundaryCondition_calculationType,
string  alpha_upperBoundaryCondition_calculationType 
)

Radial diffusion calculation function.

Takes diffusion coefficients, boundary conditions and grid elements as parameters. It caltulates model matrix by makeMatrix and then solve it by SolveMatrix method.

Parameters:
dt - time step
Lpp - plasma pause location
&Dpcpc - diffusion coefficient
&DpcpcLpp - diffusion coefficient
&Daa - diffusion coefficient
&DaaLpp - diffusion coefficient
&Dpca - diffusion coefficient
&DpcaLpp - diffusion coefficient
&L - grid element L
&pc - grid elelent pc
&alpha - grid element alpha
&Jacobian - jacobian
&pc_lowerBoundaryCondition - lower boundary condition
&pc_upperBoundaryCondition - upper boundary condition
&alpha_lowerBoundaryCondition - lower boundary condition
&alpha_upperBoundaryCondition - upper boundary condition
&pc_lowerBoundaryCondition_calculationType - lower boundary condition calculation type
&pc_upperBoundaryCondition_calculationType - upper boundary condition calculation type
&alpha_lowerBoundaryCondition_calculationType - lower boundary condition calculation type
&alpha_upperBoundaryCondition_calculationType - upper boundary condition calculation type

Definition at line 738 of file PSD.cpp.

References Matrix2D< T >::AllocateMemory(), B(), Output::echo(), gauss_solve(), gmres_wrapout(), Matrix2D< T >::initialized, Lapack(), MakeModelMatrix_3D(), Matrix3D< double >::max(), over_relaxation_diag(), PSD_parameters, GridElement::size, ParamStructure::PSD::SOL_i_max, ParamStructure::PSD::SOL_max_iter_err, ParamStructure::PSD::SOL_maxiter, ParamStructure::PSD::solutionMethod, and Matrix1D< T >::writeToFile().

Referenced by main().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::DiffusionMixTermExplicit ( double  dt,
double  Lpp,
DiffusionCoefficient Dpca,
DiffusionCoefficient DpcaLpp,
GridElement L,
GridElement pc,
GridElement alpha,
Matrix3D< double >  Jacobian,
Matrix2D< double >  pc_lowerBoundaryCondition,
Matrix2D< double >  pc_upperBoundaryCondition,
Matrix2D< double >  alpha_lowerBoundaryCondition,
Matrix2D< double >  alpha_upperBoundaryCondition,
string  pc_lowerBoundaryCondition_calculationType,
string  pc_upperBoundaryCondition_calculationType,
string  alpha_lowerBoundaryCondition_calculationType,
string  alpha_upperBoundaryCondition_calculationType 
)

Mixed terms calculation by explicit method.

Parameters:
dt - time step
Lpp - plasma pause location
&Dpca - pc-alpha diffusion coefficient
&DpcaLpp - pc-alpha diffusion coefficient under plasma pause location
&L - grid element L
&pc - grid element pc
&alpha - grid element alpha
&Jacobian - jacobian
&pc_lowerBoundaryCondition - lower boundary condition on pc
&pc_upperBoundaryCondition - upper boundary condition on pc
&alpha_lowerBoundaryCondition - lower boundary condition on alpha
&alpha_upperBoundaryCondition - upper boundary condition on alpha
pc_lowerBoundaryCondition_calculationType - pc lower boundary condition type,
pc_upperBoundaryCondition_calculationType - pc upper boundary condition type,
alpha_lowerBoundaryCondition_calculationType - alpha lower boundary condition type,
alpha_upperBoundaryCondition_calculationType - alpha upper boundary condition type.

Definition at line 180 of file PSD.cpp.

References ParamStructure::PSD::approximationMethod, VF::G(), PSD_parameters, and GridElement::size.

Referenced by main().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Initialize ( ParamStructure::PSD  parameters,
Grid grid,
Matrix2D< double >  L_UpperBoundaryCondition = Matrix2D<double>() 
)

Initializing: storing parameters, loading initial values, making boundary conditions, initializing output parameters Simply, it is a creation of the object.

Parameters:
parameters - interpolation parameters structure
&grid - grid
L_UpperBoundaryCondition - upper L boundary values, in case we need to create initial PSD as a steady state radial diffusion solution

Definition at line 83 of file PSD.cpp.

References LoadInitialValue(), ParamStructure::PSD::output_PSD_fileName4D, ParamStructure::PSD::output_PSD_folderName, output_without_grid_file, and PSD_parameters.

Referenced by PSD().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Interpolate ( PSD otherPSD,
ParamStructure::Interpolation  interpolationParamStructure,
Grid oldGrid,
Grid newGrid,
Matrix2D< double >  newGrid_pc_lowerBoundaryCondition,
Matrix2D< double >  newGrid_pc_upperBoundaryCondition 
)

Interpolation function.

It does interpolation... for log(function) or for just function, depends on parameters.

Parameters:
&otherPSD - PSD to interpolato the values from
interpolationParamStructure -
&oldGrid - old grid
&newGrid - new grid
newGrid_pc_lowerBoundaryCondition - upper energy boundary VALUE
newGrid_pc_upperBoundaryCondition - lower energy boundary VALUE

Definition at line 1015 of file PSD.cpp.

References Grid::alpha, checkInf(), Matrix1D< T >::Interpolate(), Grid::L, ParamStructure::Interpolation::linearSplineCoef, Matrix3D< double >::max(), VF::max(), ParamStructure::Interpolation::maxSecondDerivative, Grid::pc, Matrix1D< T >::Polilinear(), GridElement::size, Matrix1D< T >::Spline(), Grid::type, ParamStructure::Interpolation::type, and ParamStructure::Interpolation::useLog.

Referenced by main().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Load_initial_f ( GridElement L,
GridElement pc,
GridElement alpha,
double  tau,
double  Kp,
Matrix2D< double >  L_UpperBoundaryCondition,
double  min_f = 1.e-99,
double  fb_out = 1,
double  fb_in = 0 
)

Calculate initial PSD from steady state using boundary conditions.

Parameters:
&L - grid element L
&pc - grid element pc
&alpha - grid element alpha
tau - life time
Kp - Kp value
L_UpperBoundaryCondition - values at the outer L boundary, in case we need to create initial PSD as a steady state radial diffusion solution
min_f - minimum of finction (should be some positive value)
fb_out - upper boundary value for steady-state solution
fb_in - lower boundary value for steady-state solution

Definition at line 1382 of file PSD.cpp.

References VF::B(), i, GridElement::size, Matrix1D< T >::size_x, steady_state(), and Matrix1D< T >::writeToFile().

Here is the call graph for this function:

void PSD::Load_initial_f ( GridElement L,
GridElement pc,
GridElement alpha,
double  tau,
double  Kp,
double  min_f = 1.e-99,
string  J_L7_function = "J_L7",
double  fb_out = 1,
double  fb_in = 0 
)

Calculate initial PSD from steady state.

Parameters:
&L - grid element L
&pc - grid element pc
&alpha - grid element alpha
tau - life time
Kp - Kp value
min_f - minimum of finction (should be some positive value)
J_L7_function - parameter, J_L7 function. Can be J_L7 or J_L7_corrected
fb_out - value at the outer L boundary
fb_in - value at the inner L boundary

Definition at line 1307 of file PSD.cpp.

References VF::alc(), VF::B(), i, VF::J_L7(), VF::J_L7_corrected(), VF::Kfunc(), GridElement::size, Matrix1D< T >::size_x, steady_state(), and Matrix1D< T >::writeToFile().

Referenced by LoadInitialValue().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Load_initial_f_2d ( GridElement L,
GridElement pc,
GridElement alpha,
const char *  filename 
)

Load initial PSD from 2d-file (for 2d calculations).

Parameters:
&L - grid element L
&pc - grid element pc
&alpha - grid element alpha
*filename - file name

Definition at line 1424 of file PSD.cpp.

References VF::alc(), GridElement::GridElement_parameters, i, VF::Kfunc(), ParamStructure::GridElement::max, ParamStructure::GridElement::min, GridElement::size, and Matrix1D< T >::writeToFile().

Referenced by LoadInitialValue().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Load_initial_f_file ( GridElement L,
GridElement epc,
GridElement alpha,
const char *  filename,
bool  withGrid 
)

Load initial PSD from file.

Parameters:
&L - grid element L
&epc - grid element pc
&alpha - grid element alpha
filename - filename
withGrid - indicate if the file contains grid values

Definition at line 1260 of file PSD.cpp.

References err, and GridElement::size.

Referenced by LoadInitialValue().

Here is the caller graph for this function:

void PSD::LoadInitialValue ( ParamStructure::PSD  parameters,
Grid grid,
Matrix2D< double >  L_UpperBoundaryCondition = Matrix2D<double>() 
)

Loading initial values - from a file or other sources.

This procedure calles other depends on initialPSDType.

Parameters:
parameters - initial PSD parameters structure
&grid - grid
L_UpperBoundaryCondition - upper L boundary values, in case we need to create initial PSD as a steady state radial diffusion solution

moved to parameters.cpp if (parameters.initial_PSD_tauSteadyState <= 1.e-99) parameters.initial_PSD_tauSteadyState = 4.0/parameters.initial_PSD_Kp0;

moved to parameters.cpp if (parameters.initial_PSD_tauSteadyState <= 1.e-99) parameters.initial_PSD_tauSteadyState = 4.0/parameters.initial_PSD_Kp0;

Definition at line 1165 of file PSD.cpp.

References VF::alc(), Grid::alpha, Grid::epc, ParamStructure::PSD::initial_PSD_fileName, ParamStructure::PSD::initial_PSD_inner_psd, ParamStructure::PSD::initial_PSD_J_L7_function, ParamStructure::PSD::initial_PSD_Kp0, ParamStructure::PSD::initial_PSD_outer_psd, ParamStructure::PSD::initial_PSD_some_constant_value, ParamStructure::PSD::initial_PSD_tauSteadyState, ParamStructure::PSD::initial_PSD_Type, Matrix2D< T >::initialized, Grid::L, Load_initial_f(), Load_initial_f_2d(), Load_initial_f_file(), Grid::pc, and GridElement::size.

Referenced by Initialize().

Here is the call graph for this function:

Here is the caller graph for this function:

void PSD::Output_without_grid ( double  time  ) 

PSD output.

Parameters:
time - time

Definition at line 1238 of file PSD.cpp.

Referenced by main().

Here is the caller graph for this function:

void PSD::SourcesAndLosses ( GridElement L,
GridElement pc,
GridElement alpha,
Matrix3D< double > &  SL,
double  dt,
double  Lpp,
double  tau,
double  tauLpp 
)

Sources and losses term from the FP eq.

Parameters:
&L - L-grid array
&pc - pc-grid array
&alpha - alpha-grid array
&SL - sources/losses 3D matrix
dt - time sted
Lpp - plasmapause location
tau - lifetime outside of the plasmapause
tauLpp - lifetime inside of the plasmapause

Definition at line 112 of file PSD.cpp.

References GridElement::size.

Referenced by main().

Here is the caller graph for this function:


Member Data Documentation

Definition at line 130 of file PSD.h.

Referenced by Initialize().

Definition at line 39 of file PSD.h.

Referenced by Diffusion_pc_alpha(), DiffusionMixTermExplicit(), and Initialize().


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

Generated on Thu May 27 11:53:19 2010 for VERB_CODE_2.0 by  doxygen 1.5.9