A B C D E F G H I J K L M N O P Q R S T U V W X Y Z

C

CSat - Static variable in class spis.Top.Default.GlobalParameter
Name of the following parameter: absolute spacecraft capacitance [C] (default value: 1.e-9, type: float)
Cabs - Variable in class spis.Top.SC.EquipotSC
SC absolute capacitance
Cabs - Variable in class spis.Top.SC.RCCabsSC
SC absolute capacitance
Centring - class spis.Vol.VolMesh.Centring.
Class Name : Centring
Project ref : SPIS project
File name : Centring.java
File type : class
Copyright : ONERA, 2 Av.
Centring(Geom, int) - Constructor for class spis.Vol.VolMesh.Centring
One of the two default constructors: Geometry is first, absolute dimension follows.
Centring(int, Geom) - Constructor for class spis.Vol.VolMesh.Centring
One of the two default constructors: first relative dimension, then Geometry.
Centring(Centring) - Constructor for class spis.Vol.VolMesh.Centring
Copy constructor
Circ - class spis.Circ.Circ.Circ.
Class Name : Circ (generic spacecraft Circuit class)
Project ref : SPIS project
File name : Circ.java
File type : class
Copyright : ONERA, 2 Av.
Circ() - Constructor for class spis.Circ.Circ.Circ
 
CircField - class spis.Circ.CircField.CircField.
Class Name : CircField (generic spacecraft Circuit Field class)
Project ref : SPIS project
File name : CircField.java
File type : class
Copyright : ONERA, 2 Av.
CircField(Circ) - Constructor for class spis.Circ.CircField.CircField
Default constructor
ConjGrad3DUnstructPoissonSolver - class spis.Solver.Poisson.ConjGrad3DUnstructPoissonSolver.
Class Name : ConjGrad3DUnstructPoissonSolver
Project ref : SPIS project
File name : ConjGrad3DUnstructPoissonSolver.java
File type : class
Copyright : ONERA, 2 Av.
ConjGrad3DUnstructPoissonSolver(ThreeDUnstructVolMesh, SurfMesh, SurfMesh, PoissonBC, PoissonBC, float, float, float, float, boolean) - Constructor for class spis.Solver.Poisson.ConjGrad3DUnstructPoissonSolver
Default constructor
ConjGrad3DUnstructPoissonSolver(ThreeDUnstructVolMesh, float, float, float, float, boolean) - Constructor for class spis.Solver.Poisson.ConjGrad3DUnstructPoissonSolver
Constructor with little data, default boundary conditions will be:
- Dirichlet on spacecraft (fixed potential)
- Fourier at external boundaries (potentiel goes asymptotically to zero, within 1 meter with these pre-defined parameters)
ConjGrad3DUnstructPoissonSolver(ThreeDUnstructVolMesh) - Constructor for class spis.Solver.Poisson.ConjGrad3DUnstructPoissonSolver
Constructor with really minimum data, default boundary conditions will be:
- Dirichlet on spacecraft (fixed potential)
- Fourier at external boundaries (potentiel goes asymptotically to zero, within 1 meter)
Default data for non-linear solving are: dens = 10^11 #/m3, Te = 0.1eV.
ConjugateGradientSolve(int, Matrix, double[], double[], double, int) - Static method in class spis.Solver.Poisson.PoissonSolve
Solves a linear system mat.xSol=bSecond, through conjugate gradient method.
ConstantFunction - class spis.Util.Func.ConstantFunction.
Class Name : ConstantFunction
Project ref : SPIS project
File name : ConstantFunction.java
File type : class
Copyright : ONERA, 2 Av.
ConstantFunction(float) - Constructor for class spis.Util.Func.ConstantFunction
constructor
ConstantFunctionOfDistrib - class spis.Surf.InteractModel.ConstantFunctionOfDistrib.
Class Name : ConstantFunctionOfDistrib
Project ref : SPIS project
File name : ConstantFunctionOfDistrib.java
File type : class
Copyright : ONERA, 2 Av.
ConstantFunctionOfDistrib(float) - Constructor for class spis.Surf.InteractModel.ConstantFunctionOfDistrib
constructor
CosMultiD - class spis.Util.Func.CosMultiD.
Class Name : CosMultiD
Project ref : SPIS project
File name : CosMultiD.java
File type : class
Copyright : ONERA, 2 Av.
CosMultiD(int, float[], float[], float) - Constructor for class spis.Util.Func.CosMultiD
Default constructor, sets parameters to define the function:
(cos(kx+phix) * cos(ky+phiy) * cos(kz+phyz)...) * norm
with k=waveNumber, phi=phase, norm=normalisation (dim=3 in this expression.
c1c2F - Variable in class spis.Surf.InteractModel.SEEEYieldFunction1
array of c1 [eV-1], c2 [m-1] parameters (cf.
c1c2Params - Variable in class spis.Surf.InteractModel.SEEEYieldFunction1
c1-c2 params stored as parameter sets
c1c2Params - Variable in class spis.Surf.InteractModel.SEEPYieldFunction1
c1 [eV-1] and c2 [m-1] params stored as parameter sets (cf.
cF - Variable in class spis.Surf.InteractModel.SEEPYieldFunction1
array of c parameters (cf.
cParams - Variable in class spis.Surf.InteractModel.ProtonRangeFunction1
c parameters
cParams - Variable in class spis.Surf.InteractModel.SEEPYieldFunction1
c params stored as parameter sets
calLenWire(float[][], float[][], float[][], float[], int[][], int[][], int[][], int[], int[], int[], int, int) - Static method in class spis.Solver.Poisson.PoissonInit
 
calPointeur(int[][], int[][], int[], int[], int, int) - Static method in class spis.Solver.Poisson.PoissonInit
Compute the index of the column number of j > i for each row i of the matrix
capa - Variable in class spis.Circ.Circ.RCCabsCirc
capacitances of capacitor network
cellBary(int) - Method in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
return the barycentre of a cell
cellEdge - Variable in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
edges of a cell (int[cellNb][6])
cellNb - Variable in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
cell (tetrahedra) number
cellNode - Variable in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
nodes of a cell (int[cellNb][4]).
cellSurf - Variable in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
pointers (indices) to the surfaces surrounding a cell (int[cellNb][4]).
cellVol - Variable in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
Cell volume
cellWire - Variable in class spis.Solver.Poisson.ConjGrad3DUnstructPoissonSolver
if 0 node of cell i is wire, cellWire[i] = 0 if 1 and only 1 node of cell i is wire, cellWire[i] = 1+local number of this node if more than 1 node of cell i is wire, cellWire[i] < 0
cent - Variable in class spis.Surf.SurfField.SurfField
centring of the field (values on cells/surfaces/edges/nodes)
cent - Variable in class spis.Vol.VolField.VolField
centring of the field (values on cells/surfaces/edges/nodes)
centre - Variable in class spis.Util.Func.GradPowerLaw
Centre location
centre - Variable in class spis.Util.Func.PowerLaw
Centre location
cers - Static variable in class spis.Top.Default.SpisDefaultMaterials
 
cersComment - Static variable in class spis.Top.Default.SpisDefaultMaterials
 
cersParams - Static variable in class spis.Top.Default.SpisDefaultMaterials
 
cesium - Static variable in class spis.Top.Default.SpisDefaultPartTypes
to be referred to in UI as "Cs+"
cfrp - Static variable in class spis.Top.Default.SpisDefaultMaterials
 
cfrp2 - Static variable in class spis.Top.Default.SpisDefaultMaterials
 
cfrp2Params - Static variable in class spis.Top.Default.SpisDefaultMaterials
 
cfrpComment - Static variable in class spis.Top.Default.SpisDefaultMaterials
 
cfrpParams - Static variable in class spis.Top.Default.SpisDefaultMaterials
 
ch(float) - Static method in class spis.Util.Phys.Phys
Hyperbolic cosine function in simple precision, which is enough for physicists!
charge - Variable in class spis.Util.Part.Part
particle charge [elem charge unit]
checkDim(Table) - Method in class spis.Surf.SurfField.SurfField
Checks the dimension of the passed table is the right one for the mesh and centring of this field
checkDim(Table) - Method in class spis.Vol.VolField.VolField
Checks the dimension of the passed table is the right one for the mesh and centring of this field
checkFluxes(SurfDistrib, SurfDistrib) - Method in class spis.Surf.InteractModel.ReflectionInteractor
Checks consistency of in and out fluxes (called at object construction if fluxes not null, and at computeInteraction() time in any case).
checkHasRelDim(int) - Method in class spis.Vol.VolMesh.Centring
 
checkIsOnThisMesh(SurfField) - Method in class spis.Surf.SurfMesh.SurfMesh
tests whether this surface mesh is a surface mesh on this mesh
checkMomentConsistentWithOrder(SurfField, int) - Method in class spis.Surf.SurfDistrib.SurfDistrib
Checks the moment sub-type (ScalSurfField or VectSurfField) is consistent with the moment order.
checkMomentConsistentWithOrder(VolField, int) - Method in class spis.Vol.VolDistrib.VolDistrib
Checks the moment sub-type (ScalVolField or VectVolField) is consistent with the moment order
checkSameCentring(VolField) - Method in class spis.Vol.VolField.VolField
checks that both fields have the same centring
checkSameDim(Table) - Method in class spis.Util.Table.Table
checks equality of table dimension (logical filled dimension, not allocated length)
checkSameDims(VectTable) - Method in class spis.Util.Table.VectTable
checks equality of array both dimensions (table dimension and vector dimension)
checkSameMesh(SurfField) - Method in class spis.Surf.SurfField.SurfField
Checks the passed field has same surface mesh.
checkSameMeshAndCentring(SurfField) - Method in class spis.Surf.SurfField.SurfField
Checks the passed field has same surface mesh and centring.
checkSameSubtype(SurfField) - Method in class spis.Surf.SurfField.SurfField
Decrements this field by another field (on the spot), which must indeed be a scalar field
checkSameVectDim(VectTable) - Method in class spis.Util.Table.VectTable
checks equality of vector dimension
checkSameVectDim(float[]) - Method in class spis.Util.Table.VectTable
checks equality of vector dimension
checkVectDimIsLarger(int) - Method in class spis.Util.Table.VectTable
checks equality of vector dimension (filled size, not dimensioned size)
circ - Variable in class spis.Circ.CircField.CircField
pointer to the circuit the field "lives" on
circ - Variable in class spis.Top.SC.RCCabsSC
SC equivalent Circuit
circFieldBuffer - Variable in class spis.Top.SC.RCCabsSC
circuit field buffer
circuitReader - class spis.Util.io.circuitReader.
Class Name : circuitReader
Project ref : SPIS project
File name : circuitReader.java
File type : class
Copyright : ONERA, 2 Av.
circuitReader(String) - Constructor for class spis.Util.io.circuitReader
Default constructor
clean(TestOfInt, IntScalTable) - Method in class spis.Util.List.PartList
Cleans the list, excluding particles verifying selectPart.test(selectTable[i])
clean(TestOfInt, IntScalTable) - Method in class spis.Util.List.RichPartList
Cleans the list, excluding particles verifying selectPart.test(selectTable[i])
closeOutputFiles() - Method in class spis.Util.Monitor.ElecSuperNodeMonitor
Close monitoring output files: potentials.txt, emittedCurrents.txt, collectedCurrents.txt
coatingConduct - Variable in class spis.Top.SC.RCCabsSC
coating conductivity, stored for later update when conductivity changes
col - Variable in class spis.Util.Matrix.SparseMatrix
column index of non zero values
colCur - Variable in class spis.Util.Monitor.ElecSuperNodeMonitor
collected currents versus time (the data) Dimension: [populationNb+1][superNodeNb+1], colCurSum[i][j] deals with population i-1, super node j-1, and the sum if i=0 or j=0
colCurSum - Variable in class spis.Util.Monitor.ElecSuperNodeMonitor
collected currents summation variable (between two storages, for time smoothing) Dimension: [populationNb+1][superNodeNb+1], colCurSum[i][j] deals with population i-1, super node j-1, and the sum if i=0 or j=0
colCurSumNb - Variable in class spis.Util.Monitor.ElecSuperNodeMonitor
number of sums performed for collected currents
colCurWriter - Variable in class spis.Util.Monitor.ElecSuperNodeMonitor
FileWriter for collected currents
collectOutFluxes() - Method in class spis.Top.Plasma.MmfPlasma
 
collectedCurrent - Variable in class spis.Top.Simulation.GeoExample
collected current on spacecraft [A/face]
collectedCurrent - Variable in class spis.Top.Simulation.GeoExample2
collected current on spacecraft [A/face]
collectedCurrent - Variable in class spis.Top.Simulation.SimulationFromUIParams
collected current on SC
comment - Variable in class spis.Surf.InteractModel.ParameterSet
comment on the material/interaction/function these parameters describe (one of the parameters indeed)
comment - Variable in class spis.Top.Default.Parameter
Comment on that parameter
componentType - Variable in class spis.Circ.Circ.ElecComponent
Type of component (R, L, C, V)
compute(SurfDistrib, ScalSurfField) - Method in class spis.Surf.InteractModel.ConstantFunctionOfDistrib
 
compute(float, int) - Method in class spis.Surf.InteractModel.DampedEnergyFunction
 
compute(float) - Method in class spis.Surf.InteractModel.DiscretisedFunctionOfParticleEDeprecated
Computes the yield as a function of Energy, based on the yield table
The yield is linearly interpolated between provided values
If the energy is out of the energy interval of the table, the first or last value is returned
Simple iterative method.
compute(float, int) - Method in class spis.Surf.InteractModel.DoublePowerLawRangeFunction
 
compute(float, float, int) - Method in class spis.Surf.InteractModel.ElecBackscatterFunction
Returns the albedo of backscattered electrons
compute(float, int) - Method in class spis.Surf.InteractModel.ElecBackscatterFunction
Returns the average albedo of backscattered electrons for an isotropic distribution
compute(float, int) - Method in class spis.Surf.InteractModel.EnergyFunction
Returns particle energy
compute(SurfDistrib, ScalSurfField) - Method in class spis.Surf.InteractModel.FunctionOfDistrib
Computes the (local) result of applying this yield on the incoming surface distribution fluxIn (one value per surface element in result)
compute(SurfDistrib, ScalSurfField) - Method in class spis.Surf.InteractModel.FunctionOfDistribFromFuncOfPart
Computes the local macroscopic function of the given incoming flux (PIC or fluid or...).
compute(int) - Method in class spis.Surf.InteractModel.FunctionOfMaterial
 
compute(float[], float, float[]) - Method in class spis.Surf.InteractModel.FunctionOfParticle
generic interface allowing the computation of the function depending on particle energy, energy and angle to normal, or on nothing
compute(float[], float, float[], float, float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticle
generic interface allowing the computation of the function depending on particle energy, energy and angle to normal, or on nothing, and on the Ids of material model, material and particle
compute(float[], float, float[]) - Method in class spis.Surf.InteractModel.FunctionOfParticleE
returns the energy dependent function result, after having computed the particle energy from the inputs
compute(float[], float, float[], float, float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticleE
returns the energy dependent function result (also material dependent), after having computed the particle energy from the inputs
compute(float) - Method in class spis.Surf.InteractModel.FunctionOfParticleE
Generic way of handling non-material-indexed compute method: default parameter Id (material Id indeed) is chosen (if defined).
compute(float, float, float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticleE
Generic way of selecting the right parameter set: calls selectParamSet.
compute(float, int) - Method in class spis.Surf.InteractModel.FunctionOfParticleE
Protected abstract method to be implemented by derived classes (the only one, always the one called by the public methods defined in FunctionOfParticleE)
compute(float[], float, float[]) - Method in class spis.Surf.InteractModel.FunctionOfParticleETheta
returns the energy and angle dependent function result, after having computed the particle energy and angle from the inputs
compute(float[], float, float[], float, float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticleETheta
returns the energy and angle dependent function result (also material dependent), after having computed the particle energy and angle from the inputs
compute(float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticleETheta
Generic way of handling non-material-indexed compute method: default parameter Id (material Id indeed) is chosen (if defined).
compute(float, float, float, float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticleETheta
Generic way of selecting the right parameter set: calls selectParamSet.
compute(float, float, int) - Method in class spis.Surf.InteractModel.FunctionOfParticleETheta
Protected abstract method to be implemented by derived classes (the only one, always the one called by the public methods defined in FunctionOfParticleE)
compute(float, int) - Method in class spis.Surf.InteractModel.FunctionOfParticleETheta
Computes an isotropic function (material dependent but in a localal protected way).
compute(float, float, float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticleETheta
Computes an isotropic function (material dependent).
compute(float) - Method in class spis.Surf.InteractModel.FunctionOfParticleETheta
Computes an isotropic function (material independent).
compute(float[], float, float[]) - Method in class spis.Surf.InteractModel.FunctionOfParticleNothing
returns the particle-independent function result, not using the generic inputs in this case
compute(float[], float, float[], float, float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticleNothing
returns the particle-independent function result (but material dependent), not using the generic inputs in this case
compute() - Method in class spis.Surf.InteractModel.FunctionOfParticleNothing
Generic way of handling non-material-indexed compute method: default parameter Id (material Id indeed) is chosen (if defined).
compute(float, float, float) - Method in class spis.Surf.InteractModel.FunctionOfParticleNothing
Generic way of selecting the right parameter set: calls selectParamSet.
compute(int) - Method in class spis.Surf.InteractModel.FunctionOfParticleNothing
Protected abstract method to be implemented by derived classes (the only one, always the one called by the public methods defined in FunctionOfParticleE)
compute(float, int) - Method in class spis.Surf.InteractModel.ProtonRangeFunction1
 
compute(float, int) - Method in class spis.Surf.InteractModel.RangeFunction
Returns the range as a function of energy.
compute(float, int) - Method in class spis.Surf.InteractModel.ReciprocalOfFunctionOfParticleE
 
compute(float[], float, float[]) - Method in class spis.Surf.InteractModel.ReciprocalOfFunctionOfParticleE
Should return the energy dependent function computed from particle data, but cannot here because the reciprocal of a function of energy is not a function of energy !
compute(float[], float, float[], float, float, float) - Method in class spis.Surf.InteractModel.ReciprocalOfFunctionOfParticleE
Should return the energy dependent function computed from particle data, but cannot here because the reciprocal of a function of energy is not a function of energy !
compute(float, float, int) - Method in class spis.Surf.InteractModel.SEEEYieldFunction1
Returns the SEEE yield [-]
compute(float, int) - Method in class spis.Surf.InteractModel.SEEEYieldFunction1
Returns the average SEEE yield for an isotropic distribution [-]
compute(float, float, int) - Method in class spis.Surf.InteractModel.SEEPYieldFunction1
Returns the SEEE yield
compute(float, int) - Method in class spis.Surf.InteractModel.SEEPYieldFunction1
Returns the average SEEE yield for an isotropic distribution
compute(float, int) - Method in class spis.Surf.InteractModel.TransmissionFunction
 
compute() - Method in class spis.Util.Func.ConstantFunction
 
compute(float[]) - Method in class spis.Util.Func.CosMultiD
Returns (cos(kx+phix) * cos(ky+phiy) * cos(kz+phyz)) * norm (and more if dim larger than 3), where vect = (x, y, z, ...)
compute(float[]) - Method in class spis.Util.Func.DistToPoint
returns dist(vect, origin) to the power exp
compute(float) - Method in class spis.Util.Func.Exp
 
compute(float[], int, float[]) - Method in class spis.Util.Func.Exp
applies this exponential to the array x (0 to n-1 elements) and assigns the result to y
compute(float) - Method in interface spis.Util.Func.FunctionOfEDeprecated
Computes a function of Energy
compute(float, float) - Method in interface spis.Util.Func.FunctionOfEThetaDeprecated
Computes a function of Energy and angle to normal (radians)
compute() - Method in interface spis.Util.Func.FunctionOfNothingDeprecated
Computes a function of Nothing
compute(float) - Method in class spis.Util.Func.IsEqual
 
compute(float) - Method in class spis.Util.Func.LimitedExp
 
compute(float[], int, float[]) - Method in class spis.Util.Func.LimitedExp
applies this limited exponential to the array x (0 to n-1 elements) and assigns the result to y
compute(float) - Method in class spis.Util.Func.Ln
 
compute(float[], int, float[]) - Method in class spis.Util.Func.Ln
applies this logarithm function to the array x (0 to n-1 elements) and assigns the result to y
compute(float) - Method in class spis.Util.Func.Max
 
compute(float[]) - Method in class spis.Util.Func.PowerLaw
Returns: normalisation * |pos - center|^exponent
compute(float) - Method in class spis.Util.Func.ReciprocalFunction
 
compute(float, float) - Method in interface spis.Util.Func.ScalFunctionOf2Scal
return the result of the function of two scalar variables
compute(float, float, float) - Method in interface spis.Util.Func.ScalFunctionOf3Scal
return the result of the function of three scalar variables
compute(float, float, float, float) - Method in interface spis.Util.Func.ScalFunctionOf4Scal
return the result of the function of 4 scalar variables
compute(float, float, float, float, float) - Method in interface spis.Util.Func.ScalFunctionOf5Scal
return the result of the function of 5 scalar variables
compute() - Method in interface spis.Util.Func.ScalFunctionOfNothing
returns the result of the function of nothing (a constant)
compute(float) - Method in interface spis.Util.Func.ScalFunctionOfScal
applies this function to x and returns the result
compute(float) - Method in class spis.Util.Func.ScalFunctionOfScalFromFunctionOf4
 
compute(float) - Method in class spis.Util.Func.ScalFunctionOfScalFromFunctionOf5
 
compute(float[]) - Method in interface spis.Util.Func.ScalFunctionOfVect
 
compute(float) - Method in class spis.Util.Func.Sqrt
 
compute(float) - Method in class spis.Util.Func.TabulatedScalFunctionOfScal
Computes the y as a function of x, based on the tables.
computeAngle(SpaceVectTable, VeloVectTable, FloatScalTable, int, int, TestOfInt, IntScalTable) - Method in class spis.Vol.Geom.TwoThreeDAxisymGeom
 
computeAngleCos(SpaceVectTable, VeloVectTable, FloatScalTable) - Method in interface spis.Vol.Geom.Geom
Computes the cosine of the angle between 2 vector tables of two different sub-types
computeAngleCos(SpaceVectTable, VeloVectTable, FloatScalTable) - Method in class spis.Vol.Geom.ThreeDCartesianGeom
 
computeBarCo(float[], float, float, float, int) - Method in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
Computes barycentric coordinates barCo from cartesian coordinates with origin at first tetrahedron point (x = xParticle - xPoint1) for a point (x, y, z) in cell cellNo.
computeC(float, float, float, float) - Method in class spis.Surf.InteractModel.SEEPYieldFunction1
Compute the c parameter in proton range function
computeC1C2(float, float, RangeFunction, float[]) - Method in class spis.Surf.InteractModel.SEEEYieldFunction1
Compute the c1 [eV-1] and c2 [m-1] parameters
computeCapacitance(int, float) - Method in class spis.Surf.InteractModel.BasicMaterialModel
Computes the capacitance par surface unit [F/m2] of the material of Id matId, and thickness matThickness (returns -1 if thickness <= 0, i.e. a conductor)
computeCapacitance(int) - Method in class spis.Surf.InteractModel.BasicMaterialModel
Computes the capacitance per surface unit [F/m2] of the material of Id matId (and default thickness, defined in material database)
computeCapacitance(int, float) - Method in class spis.Surf.InteractModel.MaterialModel
Computes the capacitance par surface unit [F/m2] of the material of Id matId, and thickness matThickness
computeCapacitance(int) - Method in class spis.Surf.InteractModel.MaterialModel
Computes the capacitance par surface unit [F/m2] of the material of Id matId (and default thickness, defined in material database)
computeChargeOverMass(FloatScalTable) - Method in class spis.Util.List.PartList
 
computeChargeOverMass(FloatScalTable) - Method in class spis.Util.List.RichPartList
 
computeConductivity(int, float) - Method in class spis.Surf.InteractModel.BasicMaterialModel
Computes the conductivity par surface unit [ohm-1.m-2] of the material of Id matId, and thickness matThickness (returns -1 if thickness <= 0, i.e. a conductor)
computeConductivity(int) - Method in class spis.Surf.InteractModel.BasicMaterialModel
Computes the conductivity par surface unit [ohm-1.m-2] of the material of Id matId (and default thickness, defined in material database)
computeConductivity(int, float) - Method in class spis.Surf.InteractModel.MaterialModel
Computes the conductivity par surface unit [ohm-1.m-2] of the material of Id matId, and thickness matThickness
computeConductivity(int) - Method in class spis.Surf.InteractModel.MaterialModel
Computes the conductivity par surface unit [ohm-1.m-2] of the material of Id matId (and default thickness, defined in material database)
computeDeriv(float, float, float, float) - Method in class spis.Surf.InteractModel.DoublePowerLawRangeFunction
 
computeDeriv(float) - Method in class spis.Surf.InteractModel.DoublePowerLawRangeFunction
 
computeDeriv(float, int) - Method in class spis.Surf.InteractModel.DoublePowerLawRangeFunction
 
computeDeriv(float, float, float, float) - Method in class spis.Surf.InteractModel.ProtonRangeFunction1
 
computeDeriv(float) - Method in class spis.Surf.InteractModel.ProtonRangeFunction1
 
computeDeriv(float, int) - Method in class spis.Surf.InteractModel.ProtonRangeFunction1
 
computeDeriv(float, float, float, float) - Method in class spis.Surf.InteractModel.RangeFunction
returns dR/dE as a function of energy, depending on material Id (it is used for approximata dose profile computation close to the surface, in particular for secondary emission)
computeDeriv(float) - Method in class spis.Surf.InteractModel.RangeFunction
returns dR/dE as a function of energy
computeElectricField(PointList, VectTable) - Method in class spis.Vol.VolField.EField
Provides the values of the electric field at a list of arbitrary locations PointList (particle positions).
computeElectricField(PointList, VectTable) - Method in class spis.Vol.VolField.PotEField
Provides the values of the field at a list of arbitrary locations PointList (particle positions).
computeField(PointList, Table) - Method in class spis.Vol.VolField.DirVectVolField
Provides the values of the field at a list of arbitrary locations PointList (particle positions).
computeField(PointList, Table) - Method in class spis.Vol.VolField.PotVectVolField
Provides the values of the field at a list of arbitrary locations PointList (particle positions).
computeField(PointList, Table) - Method in class spis.Vol.VolField.ScalVolField
Provides the values of the field at a list of arbitrary locations PointList (particle positions).
computeField(PointList, Table) - Method in class spis.Vol.VolField.VolField
Provides the values of the field at a list of arbitrary locations PointList (particle positions).
computeGradient(int, int[], float[], int, int, int[][], int[][], float[], float[][], float[], int[][], float[][]) - Static method in class spis.Solver.Poisson.PoissonInit
Computes the electric field at each particle position (depending only on cell index indeed, since electric field is constant over a cell).
computeGradient(float[][], float[][], float[][], float[][], double[], float[], float[], float[], float[], int[], double[], int[][], int[][], int[][], int[][], int[][], int[][], int[], int[], int[], int[], int[], int, ThreeDUnstructVolMesh) - Static method in class spis.Solver.Poisson.PoissonInit
Computes the electric field at each particle position: linear in regular tetrahedra, specific in tetrahedra next to a wire (contrarily to the other computeGradient(...) routine).
computeGradient(PointList, ScalVolField, VectTable) - Method in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
Similar to Interpolate, but the gradient of a volume field is computed.
computeGradient(PointList, ScalVolField, VectTable) - Method in class spis.Vol.VolMesh.VolMesh
Similar to Interpolate, but the gradient of a volume field is computed.
computeHistogram(int) - Method in class spis.Util.Monitor.XyData
Generates and returns the histogram of this set of data (xi, yi):
yi is considered as the number of occurences (can be uniformly 1) of the value xi.
computeInFlux() - Method in class spis.Vol.BC.MatterBC
Returns the incoming flux as an array of surface distributions.
computeInFlux() - Method in class spis.Vol.BC.SurfDistribMatterBC
Computes and returns the incoming flux as an array of surface distributions (equivalent to the getter getInFlux in the case of this simple class).
computeInteraction() - Method in class spis.Surf.InteractModel.BasicInducedConductInteractor
 
computeInteraction(ScalSurfField) - Method in class spis.Surf.InteractModel.Interactor
Computes the interaction from the incoming flux to the outgoing flux (through Interactor internal pointer inFlux & outFlux to these fluxes), computing also the net current (collected: + in - out)
computeInteraction() - Method in class spis.Surf.InteractModel.Interactor
Computes the interaction, not computing the net current in this version
computeInteraction() - Method in class spis.Surf.InteractModel.MaxwellianInteractor
Computes the interaction for a whole flux (over the whole surface mesh).
computeInteraction() - Method in class spis.Surf.InteractModel.MaxwellianInteractorWithRecollection
Computes the interaction for a whole flux (over the whole surface mesh).
computeInteraction() - Method in class spis.Surf.InteractModel.MultipleInteractor
 
computeInteraction() - Method in class spis.Surf.InteractModel.MultipleMaxwellianInteractor
 
computeInteraction() - Method in class spis.Surf.InteractModel.ReflectionInteractor
 
computeInteraction() - Method in class spis.Surf.InteractModel.Source
Nothing to do here since the interaction is reduced to a constant surface distribution emission (a possible sampling is done when requesting getSample() from the outgoing flux)
computeInteraction(SurfDistrib, SurfDistrib, SurfField, Interactor) - Method in class spis.Surf.InteractModel.SurfInteractDeprecated
Has the interaction computed by the Interactor provided.
computeInteraction() - Method in class spis.Top.SC.InteractSC
Simulates all interactions, not computing the emitted current
computeInteraction(ScalSurfField) - Method in class spis.Top.SC.InteractSC
Simulates all interactions, computing the emitted current
computeMaps() - Method in class spis.Surf.SurfMesh.ThreeDUnstructSurfMesh
Computes mapping matrices:
- between nodes and surfaces (excluding nodes of 1D wires), mapNS*
- between nodes and edges of 1D wires, mapNE*
computeMultipleInteraction() - Method in class spis.Surf.InteractModel.Interactor
Compute interaction in case of multiple inFlux and outFlux.
computeNeighbouringData() - Method in class spis.Surf.SurfMesh.SurfMesh
Computes and returns data characterising neighbour cells of a cell (needed for surface conductivity).
computeNeighbouringData() - Method in class spis.Surf.SurfMesh.ThreeDUnstructSurfMesh
Computes and returns data characterising neighbour cells of a cell (needed for surface conductivity).
computeNormals() - Method in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
Computes surface normals and makes a few checks.
computePot(PointList, FloatScalTable) - Method in class spis.Vol.VolField.DirVectVolField
Provides the potential at a list of arbitrary locations PointList (particle positions).
computePot(PointList, FloatScalTable) - Method in class spis.Vol.VolField.PotVectVolField
Provides the potential at a list of arbitrary locations PointList (particle positions).
computePot(PointList, FloatScalTable) - Method in class spis.Vol.VolField.VectVolField
Provides the potential at a list of arbitrary locations PointList (particle positions).
computePotential(PointList, FloatScalTable) - Method in class spis.Vol.VolField.PotEField
Provides the values of the field at a list of arbitrary locations PointList (particle positions).
computeRnOverR2() - Method in class spis.Top.Simulation.SimulationFromUIParams
Computes and returns r.n/(r.r), where r is the vector field of bd mesh surface positions (centres) with origin the SC mesh barycentre, and n is the vector field of the (outgoing) normals to the external boundary mesh.
computeScalProd(VectSurfField) - Method in class spis.Surf.SurfField.VectSurfField
Computes the scalar product with another vector field and returns the result
computeScalProd(float[]) - Method in class spis.Surf.SurfField.VectSurfField
Computes the scalar product with a fixed vector and returns the result
computeScalProd(VectTable, FloatScalTable) - Method in class spis.Util.Table.VectTable
Computes the scalar product of this table with the passed table vt
computeSecondDeriv(float, float, float, float) - Method in class spis.Surf.InteractModel.DoublePowerLawRangeFunction
 
computeSecondDeriv(float) - Method in class spis.Surf.InteractModel.DoublePowerLawRangeFunction
 
computeSecondDeriv(float, int) - Method in class spis.Surf.InteractModel.DoublePowerLawRangeFunction
 
computeSecondDeriv(float, float, float, float) - Method in class spis.Surf.InteractModel.ProtonRangeFunction1
 
computeSecondDeriv(float) - Method in class spis.Surf.InteractModel.ProtonRangeFunction1
 
computeSecondDeriv(float, int) - Method in class spis.Surf.InteractModel.ProtonRangeFunction1
 
computeSecondDeriv(float, float, float, float) - Method in class spis.Surf.InteractModel.RangeFunction
returns d2R/dE2 as a function of energy, depending on material Id (it may be used for approximata dose profile computation close to the surface, in particular for secondary emission)
computeSecondDeriv(float) - Method in class spis.Surf.InteractModel.RangeFunction
returns d2R/dE2 as a function of energy
computeSpaceIncrement(SpaceVectTable, VeloVectTable, float) - Method in interface spis.Vol.Geom.Geom
Computes the space increment dx resulting from the movement at velovity v during the time dt (formally dx = v dt)
computeSpaceIncrement(SpaceVectTable, VeloVectTable, float) - Method in class spis.Vol.Geom.ThreeDCartesianGeom
Computes the space increment dx resulting from the movement at velovity v during the time dt (formally dx = v dt)
computeSpaceIncrement(SpaceVectTable, VeloVectTable, float) - Method in class spis.Vol.Geom.TwoThreeDAxisymGeom
Computes the space increment dx resulting from the movement at velovity v during the time dt:
- dz = Vz dt
- dr = Vr dt
computeSurfaceConductivity(int) - Method in class spis.Surf.InteractModel.BasicMaterialModel
Computes the surface conductivity of the material of Id matId (in [ohm-1] corresponding to surface resistivity in [ohm] sometimes called [ohm/square]).
computeSurfaceConductivity(int) - Method in class spis.Surf.InteractModel.MaterialModel
Computes the surface conductivity of the material of Id matId (in [ohm-1] corresponding to surface resistivity in [ohm] sometimes called [ohm/square])
computeTableAverage() - Method in class spis.Util.Table.FloatScalTable
Returns the average of the Table values.
computeTableL2Norm() - Method in class spis.Util.Table.FloatScalTable
Returns the L2 norm of the Table: sqrt(sum values^2).
computeTableLInfNorm() - Method in class spis.Util.Table.FloatScalTable
Returns the L-infinity norm of the Table: max(abs(val[i]).
computeTableQuadraticAverage() - Method in class spis.Util.Table.FloatScalTable
Returns the table quadratic average: sqrt((sum values^2) / numberOfValues).
computeTableSum() - Method in class spis.Util.Table.FloatScalTable
Returns the sum of the Table values.
computeTableSum() - Method in class spis.Util.Table.VectTable
Returns the sum of the Table vectors.
computeToBarCoMatrices() - Method in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
Computes the matrix toBarCo transforming cartesian coordinates into barycentric coordinates.
computeTotalChargeDensity(int) - Method in class spis.Top.Plasma.MmfPlasma
Computes the total current of the populations of the plasma and stores it in totDens.
computeVeloIncrement(VeloVectTable, VeloVectTable, float, VeloVectTable, SpaceVectTable) - Method in interface spis.Vol.Geom.Geom
Computes the velocity increment dv resulting from the acceleratin a during the time dt (formally dv = a dt).
computeVeloIncrement(VeloVectTable, VeloVectTable, float, VeloVectTable, SpaceVectTable) - Method in class spis.Vol.Geom.ThreeDCartesianGeom
Computes the velocity increment dv resulting from the acceleratin a during the time dt (formally dv = a dt)
computeVeloIncrement(VeloVectTable, VeloVectTable, float, VeloVectTable, SpaceVectTable) - Method in class spis.Vol.Geom.TwoThreeDAxisymGeom
Computes the velocity increment dv resulting from the acceleratin a during the time dt (formally dv = a dt)

Status: under development

Versions and anomalies correction :
Version numberAuthor (name, e-mail) Corrections/Modifications 0.1 JF Roussel, roussel@onecert.frCreation

computeVeloIncrement(VeloVectTable, VeloVectTable, float, VeloVectTable, SpaceVectTable, int, int, TestOfInt, IntScalTable) - Method in class spis.Vol.Geom.TwoThreeDAxisymGeom
 
computeVeloSquared(VeloVectTable, FloatScalTable) - Method in interface spis.Vol.Geom.Geom
Computes the sqaure of the velovity
computeVeloSquared(VeloVectTable, FloatScalTable) - Method in class spis.Vol.Geom.ThreeDCartesianGeom
 
computeVeloSquared(VeloVectTable, FloatScalTable, int, int, TestOfInt, IntScalTable) - Method in class spis.Vol.Geom.TwoThreeDAxisymGeom
 
concat(PartList) - Method in class spis.Util.List.PartList
concatenates the provided list plIn to this list.
concat(PartList) - Method in class spis.Util.List.RichPartList
concatenates the provided list plIn to this list.
concat(FloatScalTable) - Method in class spis.Util.Table.FloatScalTable
concatenates this table with the passed table
concat(float[], int) - Method in class spis.Util.Table.FloatScalTable
concatenates this table with the first 'length' values of the passed array (f[0:length-1])
concat(float[]) - Method in class spis.Util.Table.FloatScalTable
concatenates this table with the passed array
conduct - Variable in class spis.Circ.Circ.RCCabsCirc
conductances of resistor network
conductivity - Variable in class spis.Surf.InteractModel.ElecBackscatterFunction
function returning the bulkconductivity of the material
containsOnly(Part) - Method in class spis.Vol.VolDistrib.GlobalMaxwellBoltzmannVolDistrib
 
containsOnly(Part) - Method in class spis.Vol.VolDistrib.PICVolDistrib
 
containsOnly(Part) - Method in class spis.Vol.VolDistrib.VolDistrib
 
copy(float[][]) - Static method in class spis.Util.Vect.Array
copies a rectangular array
copy(float[]) - Static method in class spis.Util.Vect.Array
copies a 1D array
copy(int[][]) - Static method in class spis.Util.Vect.Array
copies a rectangular array
copy(int[]) - Static method in class spis.Util.Vect.Array
copies a 1D array
cos(float) - Static method in class spis.Util.Phys.Phys
Cosine function in simple precision, which is enough for physicists!
curBuf - Variable in class spis.Surf.SurfField.ScalSurfField
buffer field (to avoid permanent memory allocation-deallocation)
curBuf - Variable in class spis.Util.Monitor.ElecSuperNodeMonitor
current buffer: a surface-centred surface field on the sc mesh
currentDeposit(PartList, ScalSurfField) - Method in class spis.Surf.SurfMesh.SurfMesh
Performs the deposit of charges of the particle list pl in the current cur.
currentDeposit(PartList, ScalSurfField) - Method in class spis.Surf.SurfMesh.ThreeDUnstructSurfMesh
Performs the deposit of charges of the particle list pl in the current cur.
currentDeposit(PartList, VectVolField) - Method in class spis.Vol.VolMesh.ThreeDUnstructVolMesh
Performs the PIC deposit of current of the particle list pl in the current density cur.
currentDeposit(PartList, VectVolField) - Method in class spis.Vol.VolMesh.VolMesh
Performs the PIC deposit of current of the particle list pl in the current density cur.
cuthilMackee(int[][], int[][], int[], int[], int[], int, int, int) - Static method in class spis.Solver.Poisson.PoissonInit
Cuthil-Mac Kee Renumbering of the mesh and building of the indexes of the matrices.
A B C D E F G H I J K L M N O P Q R S T U V W X Y Z