|
|
| | Komplex_Vector (const Epetra_BlockMap &Map, bool zeroOut=true) |
| | Basic Komplex_Vector constuctor. More...
|
| |
| | Komplex_Vector (const Epetra_BlockMap &Map, const Epetra_Vector &br, const Epetra_Vector &bi) |
| | General Komplex_Vector constructor. More...
|
| |
|
| Komplex_Vector (const Komplex_Vector &Source) |
| | Komplex_Vector copy constructor.
|
| |
| | Komplex_Vector (Epetra_DataAccess CV, const Epetra_BlockMap &Map, const Komplex_MultiVector &Source, int Index) |
| | Set vector values from a vector in an existing Komplex_MultiVector. More...
|
| |
|
virtual | ~Komplex_Vector () |
| | Komplex_Vector destructor.
|
| |
|
| int | ReplaceGlobalValues (int NumEntries, double *Values, int *Indices) |
| | Replace values in a vector with a given indexed list of values, indices are in global index space. More...
|
| |
| int | ReplaceMyValues (int NumEntries, double *Values, int *Indices) |
| | Replace values in a vector with a given indexed list of values, indices are in local index space. More...
|
| |
| int | SumIntoGlobalValues (int NumEntries, double *Values, int *Indices) |
| | Sum values into a vector with a given indexed list of values, indices are in global index space. More...
|
| |
| int | SumIntoMyValues (int NumEntries, double *Values, int *Indices) |
| | Sum values into a vector with a given indexed list of values, indices are in local index space. More...
|
| |
| int | ReplaceGlobalValues (int NumEntries, int BlockOffset, double *Values, int *Indices) |
| | Replace values in a vector with a given indexed list of values at the specified BlockOffset, indices are in global index space. More...
|
| |
| int | ReplaceMyValues (int NumEntries, int BlockOffset, double *Values, int *Indices) |
| | Replace values in a vector with a given indexed list of values at the specified BlockOffset, indices are in local index space. More...
|
| |
| int | SumIntoGlobalValues (int NumEntries, int BlockOffset, double *Values, int *Indices) |
| | Sum values into a vector with a given indexed list of values at the specified BlockOffset, indices are in global index space. More...
|
| |
| int | SumIntoMyValues (int NumEntries, int BlockOffset, double *Values, int *Indices) |
| | Sum values into a vector with a given indexed list of values at the specified BlockOffset, indices are in local index space. More...
|
| |
|
| int | Scale (double ScalarValue) |
| | Scale the current values of the this vector, this = ScalarValue*this. More...
|
| |
| int | Scale (double ScalarA, const Komplex_Vector &A) |
| | Replace vector values with scaled values of A, this = ScalarA*A. More...
|
| |
| int | Norm1 (double &Result) const |
| | Compute 1-norm of the this vector. More...
|
| |
| int | Norm2 (double &Result) const |
| | Compute 2-norm of the this vector. More...
|
| |
| int | NormInf (double &Result) const |
| | Compute Inf-norm of the this vector. More...
|
| |
|
| Komplex_Vector & | operator= (const Komplex_Vector &Source) |
| | = Operator. More...
|
| |
| double & | operator[] (int index) |
| | Element access function. More...
|
| |
| const double & | operator[] (int index) const |
| | Element access function. More...
|
| |
|
|
int | Length () const |
| | Returns the length of the vector.
|
| |
| int | ReplaceMap (const Epetra_BlockMap &map) |
| |
|
|
void | Print (ostream &os) const |
| | Print method.
|
| |
|
| | Komplex_Vector (const Epetra_BlockMap &Map, bool zeroOut=true) |
| | Basic Komplex_Vector constuctor. More...
|
| |
| | Komplex_Vector (const Epetra_BlockMap &Map, const Epetra_Vector &br, const Epetra_Vector &bi) |
| | General Komplex_Vector constructor. More...
|
| |
|
| Komplex_Vector (const Komplex_Vector &Source) |
| | Komplex_Vector copy constructor.
|
| |
| | Komplex_Vector (Komplex_DataAccess CV, const Epetra_BlockMap &Map, const Komplex_MultiVector &Source, int Index) |
| | Set vector values from a vector in an existing Komplex_MultiVector. More...
|
| |
|
virtual | ~Komplex_Vector () |
| | Komplex_Vector destructor.
|
| |
|
| int | ReplaceGlobalValues (int NumEntries, double *Values, int *Indices) |
| | Replace values in a vector with a given indexed list of values, indices are in global index space. More...
|
| |
| int | ReplaceMyValues (int NumEntries, double *Values, int *Indices) |
| | Replace values in a vector with a given indexed list of values, indices are in local index space. More...
|
| |
| int | SumIntoGlobalValues (int NumEntries, double *Values, int *Indices) |
| | Sum values into a vector with a given indexed list of values, indices are in global index space. More...
|
| |
| int | SumIntoMyValues (int NumEntries, double *Values, int *Indices) |
| | Sum values into a vector with a given indexed list of values, indices are in local index space. More...
|
| |
| int | ReplaceGlobalValues (int NumEntries, int BlockOffset, double *Values, int *Indices) |
| | Replace values in a vector with a given indexed list of values at the specified BlockOffset, indices are in global index space. More...
|
| |
| int | ReplaceMyValues (int NumEntries, int BlockOffset, double *Values, int *Indices) |
| | Replace values in a vector with a given indexed list of values at the specified BlockOffset, indices are in local index space. More...
|
| |
| int | SumIntoGlobalValues (int NumEntries, int BlockOffset, double *Values, int *Indices) |
| | Sum values into a vector with a given indexed list of values at the specified BlockOffset, indices are in global index space. More...
|
| |
| int | SumIntoMyValues (int NumEntries, int BlockOffset, double *Values, int *Indices) |
| | Sum values into a vector with a given indexed list of values at the specified BlockOffset, indices are in local index space. More...
|
| |
|
| int | Scale (double ScalarValue) |
| | Scale the current values of the this vector, this = ScalarValue*this. More...
|
| |
| int | Scale (double ScalarA, const Komplex_Vector &A) |
| | Replace vector values with scaled values of A, this = ScalarA*A. More...
|
| |
| int | Norm1 (double &Result) const |
| | Compute 1-norm of the this vector. More...
|
| |
| int | Norm2 (double &Result) const |
| | Compute 2-norm of the this vector. More...
|
| |
| int | NormInf (double &Result) const |
| | Compute Inf-norm of the this vector. More...
|
| |
|
| Komplex_Vector & | operator= (const Komplex_Vector &Source) |
| | = Operator. More...
|
| |
| double & | operator[] (int index) |
| | Element access function. More...
|
| |
| const double & | operator[] (int index) const |
| | Element access function. More...
|
| |
|
|
int | Length () const |
| | Returns the length of the vector.
|
| |
| int | ReplaceMap (const Epetra_BlockMap &map) |
| |
|
|
void | Print (ostream &os) const |
| | Print method.
|
| |
| int | ReplaceMap (const Epetra_BlockMap &map) |
| | Replace map, only if new map has same point-structure as current map. More...
|
| |
|
void | PrintReal (ostream &os) |
| |
|
void | PrintImag (ostream &os) |
| |
|
int | ReplaceMap (const Epetra_BlockMap &Map) |
| | Replace map, only if new map has same point-structure as current map.
|
| |
| | Komplex_MultiVector (const Epetra_BlockMap &Map, int NumVectors, bool RHS, bool zeroOut=true, Komplex_KForms KForm=K1) |
| | Basic Komplex_MultiVector constuctor. More...
|
| |
|
| Komplex_MultiVector (const Komplex_MultiVector &Source) |
| | Komplex_MultiVector copy constructor.
|
| |
| | Komplex_MultiVector (Epetra_DataAccess CV, const Epetra_BlockMap &Map, double *A, int MyLDA, int NumVectors, bool RHS, Komplex_KForms KForm=K1) |
| | Set multivector values from two-dimensional array. More...
|
| |
| | Komplex_MultiVector (Epetra_DataAccess CV, const Epetra_BlockMap &Map, double *Real, double *Imag, int MyLDA, int NumVectors, bool RHS, Komplex_KForms KForm=K1) |
| | Set multivector values from two two-dimensional arrays. More...
|
| |
| | Komplex_MultiVector (Epetra_DataAccess CV, const Epetra_BlockMap &Map, double **ArrayOfPointers, int NumVectors, bool RHS, Komplex_KForms KForm=K1) |
| | Set multivector values from array of pointers. More...
|
| |
| | Komplex_MultiVector (Epetra_DataAccess CV, const Epetra_BlockMap &Map, double **AOPReal, double **AOPImag, int NumVectors, bool RHS, Komplex_KForms KForm=K1) |
| | Set multivector values from two arrays of pointers, representing the real and imaginary parts. More...
|
| |
| | Komplex_MultiVector (Epetra_DataAccess CV, const Epetra_MultiVector &Source, int *Indices, int NumVectors, bool RHS, Komplex_KForms KForm=K1) |
| | Set multivector values from list of vectors in an existing Epetra_MultiVector. More...
|
| |
| | Komplex_MultiVector (Epetra_DataAccess CV, const Epetra_MultiVector &Source, int StartIndex, int NumVectors, bool RHS, Komplex_KForms KForm=K1) |
| | Set multivector values from range of vectors in an existing Epetra_MultiVector. More...
|
| |
| | Komplex_MultiVector (Epetra_DataAccess CV, const Epetra_MultiVector &Source, bool RHS, Komplex_KForms KForm=K1) |
| | Set multivector values from an existing Epetra_MultiVector, with the real and imaginary parts interleaved. More...
|
| |
| | Komplex_MultiVector (Epetra_DataAccess CV, const Epetra_MultiVector &Real, const Epetra_MultiVector &Imag, bool RHS, Komplex_KForms KForm=K1) |
| | Set multivector values from two Epetra_MultiVectors, one representing the real and the other the imaginary values. More...
|
| |
|
virtual | ~Komplex_MultiVector () |
| | Komplex_MultiVector destructor.
|
| |
| int | ReplaceGlobalValue (int GlobalRow, int VectorIndex, double ScalarValue) |
| | Replace current value at the specified (GlobalRow, VectorIndex) location with ScalarValue. More...
|
| |
| int | SumIntoGlobalValue (int GlobalRow, int VectorIndex, double ScalarValue) |
| | Add ScalarValue to existing value at the specified (GlobalRow, VectorIndex) location. More...
|
| |
| int | ReplaceMyValue (int MyRow, int VectorIndex, double ScalarValue) |
| | Replace current value at the specified (MyRow, VectorIndex) location with ScalarValue. More...
|
| |
| int | SumIntoMyValue (int MyRow, int VectorIndex, double ScalarValue) |
| | Add ScalarValue to existing value at the specified (MyRow, VectorIndex) location. More...
|
| |
| int | PutScalar (double ScalarConstant) |
| | Initialize all values in a multivector with constant value. More...
|
| |
| int | Random () |
| | Set multivector values to random numbers. More...
|
| |
|
void | CreateOtherMap () |
| | Creates a map one-half or twice the size of the existing map, allowing for return of the real parts, the imaginary parts, or an interleaved multivector when given the opposite in the constructor.
|
| |
| int | Dot (const Komplex_MultiVector &A, double *Result) const |
| | Computes dot product of each corresponding pair of vectors. More...
|
| |
| int | Abs (const Komplex_MultiVector &A) |
| | Puts element-wise absolute values of input multivector in target. More...
|
| |
| int | Reciprocal (const Komplex_MultiVector &A) |
| | Puts element-wise reciprocal values of input multivector in target. More...
|
| |
| int | Scale (double ScalarValue) |
| | Scale the current values of a multivector, this = ScalarValue*this. More...
|
| |
| int | Scale (double ScalarA, const Komplex_MultiVector &A) |
| | Replace multivector values with scaled values of A, this = ScalarA*A. More...
|
| |
| int | Update (double ScalarA, const Komplex_MultiVector &A, double ScalarThis) |
| | Update multivector values with scaled values of A, this = ScalarThis*this + ScalarA*A. More...
|
| |
| int | Update (double ScalarA, const Komplex_MultiVector &A, double ScalarB, const Komplex_MultiVector &B, double ScalarThis) |
| | Update multivector with scaled values of A and B, this = ScalarThis*this + ScalarA*A + ScalarB*B. More...
|
| |
| int | Norm1 (double *Result) const |
| | Compute the 1-norm of each vector in multivector. More...
|
| |
| int | ComplexNorm1 (double *Result) const |
| | Compute the 1-norm of each vector, regarded as a complex vector, in multivector. More...
|
| |
| int | Norm2 (double *Result) const |
| | Compute the 2-norm of each vector in multivector. More...
|
| |
| int | ComplexNorm2 (double *Result) const |
| | Compute the 2-norm of each vector, regarded as a complex vector, in multivector. More...
|
| |
| int | NormInf (double *Result) const |
| | Compute the Inf-norm of each vector in multivector. More...
|
| |
| int | ComplexNormInf (double *Result) const |
| | Compute the Inf-norm of each vector, regarded as a comnplex vector, in multivector. More...
|
| |
| int | NormWeighted (const Epetra_MultiVector &Weights, double *Result) const |
| | Compute the Weighted 2-norm (RMS Norm) of each vector in multivector. More...
|
| |
| int | MinValue (double *Result) const |
| | Compute minimum value of each vector in multivector. More...
|
| |
| int | MaxValue (double *Result) const |
| | Compute maximum value of each vector in multivector. More...
|
| |
| int | MeanValue (double *Result) const |
| | Compute mean (average) value of each vector in multivector. More...
|
| |
| int | SetSeed (unsigned int Seed) |
| | Set seed for Random function. More...
|
| |
| unsigned int | Seed () const |
| | Get seed from Random function. More...
|
| |
| Komplex_MultiVector & | operator= (const Komplex_MultiVector &Source) |
| | = Operator. More...
|
| |
| double *& | operator[] (int i) |
| | Vector access function. More...
|
| |
| double *const & | operator[] (int i) const |
| | Vector access function. More...
|
| |
| Epetra_MultiVector * | EpetraMultiVector () const |
| | Vector access function. More...
|
| |
| Epetra_MultiVector * | RealMultiVector () const |
| | Conversion of real parts to Epetra_MultiVector. More...
|
| |
| Epetra_MultiVector * | ImagMultiVector () const |
| | Conversion of imaginary parts to Epetra_MultiVector. More...
|
| |
| Epetra_Vector * | EpetraVector (int index) const |
| | Single vector conversion to Epetra_Vector. More...
|
| |
| Epetra_Vector * | RealVector (int index) const |
| | Single vector conversion to Epetra_Vector, including only the real values. More...
|
| |
| Epetra_Vector * | ImagVector (int index) const |
| | Single vector conversion to Epetra_Vector, including only the imaginary values. More...
|
| |
| double *& | RealValues (int i) const |
| | Vector access function. More...
|
| |
| double *& | ImagValues (int i) const |
| | Vector access function. More...
|
| |
|
int | NumVectors () const |
| | Returns the number of vectors in the multivector.
|
| |
|
int | MyLength () const |
| | Returns the local vector length on the calling processor of vectors in the multivector.
|
| |
|
int | GlobalLength () const |
| | Returns the global vector length of vectors in the multivector.
|
| |
|
Komplex_KForms | KForm () const |
| | Returns the current K form.
|
| |
|
bool | RHS () const |
| | Returns true if this is a right-hand side multivector, false otherwise.
|
| |
| int | SwitchKForm (Komplex_KForms NewKForm) |
| | Switches the current K form. More...
|
| |
| | Komplex_MultiVector (const Epetra_BlockMap &Map, int NumVectors, bool zeroOut=true) |
| | Basic Komplex_MultiVector constuctor with one map. More...
|
| |
| | Komplex_MultiVector (const Epetra_BlockMap &MapReal, const Epetra_BlockMap &MapImag, int NumVectors, bool zeroOut=true) |
| | Basic Komplex_MultiVector constuctor with two maps. More...
|
| |
| | Komplex_MultiVector (const Epetra_BlockMap &Map, const Epetra_MultiVector &Br, const Epetra_MultiVector &Bi) |
| | General Komplex_MultiVector constructor with one map. More...
|
| |
| | Komplex_MultiVector (const Epetra_BlockMap &MapReal, const Epetra_BlockMap &MapImag, const Epetra_MultiVector &Br, const Epetra_MultiVector &Bi) |
| | General Komplex_MultiVector constructor with two maps. More...
|
| |
|
| Komplex_MultiVector (const Komplex_MultiVector &Source) |
| | Komplex_MultiVector copy constructor.
|
| |
| | Komplex_MultiVector (Komplex_DataAccess CV, const Komplex_MultiVector &Source, int *Indices, int NumVectors) |
| | Set multi-vector values from list of vectors in an existing Komplex_MultiVector. More...
|
| |
| | Komplex_MultiVector (Komplex_DataAccess CV, const Komplex_MultiVector &Source, int StartIndex, int NumVectors) |
| | Set multi-vector values from range of vectors in an existing Komplex_MultiVector. More...
|
| |
|
virtual | ~Komplex_MultiVector () |
| | Komplex_MultiVector destructor.
|
| |
| int | Scale (double ScalarValue) |
| | Scale the current values of a multi-vector, this = ScalarValue*this. More...
|
| |
| part separately int | Scale (double ScalarValueReal, double ScalarValueImag) |
| | Scale the current values of a multi-vector, scaling the real and the imaginary. More...
|
| |
| int | Scale (double ScalarA, const Komplex_MultiVector &A) |
| | Replace multi-vector values with scaled values of A, this = ScalarA*A. More...
|
| |
| parts separately int | Scale (double ScalarAReal, double ScalarAImag, const Komplex_MultiVector &A) |
| | Replace multi-vector values with scaled values of A, scaling the real and the imaginary. More...
|
| |
| int | Norm1 (double *Result) const |
| | Compute 1-norm of each vector in multi-vector. More...
|
| |
| int | Norm2 (double *Result) const |
| | Compute 2-norm of each vector in multi-vector. More...
|
| |
| int | NormInf (double *Result) const |
| | Compute Inf-norm of each vector in multi-vector. More...
|
| |
| int | Multiply (char TransA, char TransB, double ScalarAB, const Komplex_MultiVector &A, const Komplex_MultiVector &B, double ScalarThis) |
| | Matrix-Matrix multiplication, this = ScalarThis*this + ScalarAB*A*B. More...
|
| |
| int | Multiply (double ScalarAB, const Komplex_MultiVector &A, const Komplex_MultiVector &B, double ScalarThis) |
| | Multiply a Komplex_MultiVector with another, element-by-element. More...
|
| |
| Komplex_MultiVector & | operator= (const Komplex_MultiVector &Source) |
| | = Operator. More...
|
| |
| double *& | operator[] (int i) |
| | Vector access function. More...
|
| |
| double *const & | operator[] (int i) const |
| | Vector access function. More...
|
| |
| Komplex_Vector *& | operator() (int i) |
| | Vector access function. More...
|
| |
| const Komplex_Vector *& | operator() (int i) const |
| | Vector access function. More...
|
| |
|
int | NumVectors () const |
| | Returns the number of vectors in the multi-vector.
|
| |
|
int | MyLength () const |
| | Returns the local vector length on the calling processor of vectors in the multi-vector.
|
| |
|
int | GlobalLength () const |
| | Returns the global vector length of vectors in the multi-vector.
|
| |
|
int | Stride () const |
| | Returns the stride between vectors in the multi-vector (only meaningful if ConstantStride() is true).
|
| |
|
bool | ConstantStride () const |
| | Returns true if this multi-vector has constant stride between vectors.
|
| |
|
void | Print (ostream &os) const |
| | Print method.
|
| |
| | with (ScalarValueReal, ScalarValueImag).int ReplaceGlobalValue(int GlobalRow |
| | Replace current (Real, Imaginary) value at the specified (GlobalRow, VectorIndex) location. More...
|
| |
| with ScalarValue int | ReplaceGlobalValueReal (int GlobalRow, int VectorIndex, double ScalarValue) |
| | Replace real part of the current value at the specified (GlobalRow, VectorIndex) location. More...
|
| |
| with ScalarValue int | ReplaceGlobalValueImag (int GlobalRow, int VectorIndex, double ScalarValue) |
| | Replace imaginary part of the current value at the specified (GlobalRow, VectorIndex) location. More...
|
| |
| location | with (ScalarValueReal, ScalarValueImaginary).int ReplaceGlobalValue(int GlobalBlockRow |
| | Replace current (Real, Imaginary) value at the specified (GlobalBlockRow, BlockRowOffset, VectorIndex) More...
|
| |
| location with ScalarValue int | ReplaceGlobalValueReal (int GlobalBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValue) |
| | Replace real part of the current value at the specified (GlobalBlockRow, BlockRowOffset, VectorIndex) More...
|
| |
| location with ScalarValue int | ReplaceGlobalValueImag (int GlobalBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValue) |
| | Replace imaginary part of the current value at the specified (GlobalBlockRow, BlockRowOffset, VectorIndex) More...
|
| |
| int | SumIntoGlobalValue (int GlobalRow, int VectorIndex, double ScalarValueReal, double ScalarValueImag) |
| | Adds the given real and imaginary values to existing values at the specified (GlobalRow, VectorIndex) location. More...
|
| |
| int | SumIntoGlobalValueReal (int GlobalRow, int VectorIndex, double ScalarValue) |
| | Adds the given real value to existing real value at the specified (GlobalRow, VectorIndex) location. More...
|
| |
| int | SumIntoGlobalValueImag (int GlobalRow, int VectorIndex, double ScalarValue) |
| | Adds the given imaginary value to existing imaginary value at the specified (GlobalRow, VectorIndex) location. More...
|
| |
| int | SumIntoGlobalValue (int GlobalBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValueReal, double ScalarValueImag) |
| | Adds the given real and imaginary values to existing value at the specified (GlobalBlockRow, BlockRowOffset, VectorIndex) location. More...
|
| |
| int | SumIntoGlobalValueReal (int GlobalBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValue) |
| | Adds the given real value to existing real value at the specified (GlobalBlockRow, BlockRowOffset, VectorIndex) location. More...
|
| |
| int | SumIntoGlobalValueImag (int GlobalBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValue) |
| | Adds the given imaginary value to existing imaginary value at the specified (GlobalBlockRow, BlockRowOffset, VectorIndex) location. More...
|
| |
| int | ReplaceMyValue (int MyRow, int VectorIndex, double ScalarValueReal, double ScalarValueImag) |
| | Replace current value at the specified (MyRow, VectorIndex) location with (ScalarValueReal, ScalarValueImag). More...
|
| |
| int | ReplaceMyValueReal (int MyRow, int VectorIndex, double ScalarValue) |
| | Replace current real value at the specified (MyRow, VectorIndex) location with ScalarValue. More...
|
| |
| int | ReplaceMyValueImag (int MyRow, int VectorIndex, double ScalarValue) |
| | Replace current imaginary value at the specified (MyRow, VectorIndex) location with ScalarValue. More...
|
| |
| ScalarValueImag int | ReplaceMyValue (int MyBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValueReal, double ScalarValueImag) |
| | Replace current value at the specified (MyBlockRow, BlockRowOffset, VectorIndex) location with (ScalarValueReal,. More...
|
| |
| int | ReplaceMyValueReal (int MyBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValue) |
| | Replace current real value at the specified (MyBlockRow, BlockRowOffset, VectorIndex) location with ScalarValue. More...
|
| |
| int | ReplaceMyValueImag (int MyBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValue) |
| | Replace current imaginary value at the specified (MyBlockRow, BlockRowOffset, VectorIndex) location with ScalarValue. More...
|
| |
| int | SumIntoMyValue (int MyRow, int VectorIndex, double ScalarValueReal, double ScalarValueImag) |
| | Adds (ScalarValueReal, ScalarValueImag) to existing value at the specified (MyRow, VectorIndex) location. More...
|
| |
| int | SumIntoMyValueReal (int MyRow, int VectorIndex, double ScalarValue) |
| | Adds ScalarValue to existing real part of the value at the specified (MyRow, VectorIndex) location. More...
|
| |
| int | SumIntoMyValueImag (int MyRow, int VectorIndex, double ScalarValue) |
| | Adds ScalarValue to existing imaginary part of the value at the specified (MyRow, VectorIndex) location. More...
|
| |
| int | SumIntoMyValue (int MyBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValueReal, double ScalarValueImag) |
| | Adds (ScalarValueReal, ScalarValueImag) to existing value at the specified (MyBlockRow, BlockRowOffset, VectorIndex) location. More...
|
| |
| int | SumIntoMyValueReal (int MyBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValue) |
| | Adds ScalarValue to existing real part of the value at the specified (MyBlockRow, BlockRowOffset, VectorIndex) location. More...
|
| |
| int | SumIntoMyValueImag (int MyBlockRow, int BlockRowOffset, int VectorIndex, double ScalarValue) |
| | Adds ScalarValue to existing imaginary part of the value at the specified (MyBlockRow, BlockRowOffset, VectorIndex) location. More...
|
| |