44#ifndef EPETRAEXT_DISTARRAY_H
45#define EPETRAEXT_DISTARRAY_H
49#include "Epetra_Map.h"
50#include "Epetra_DistObject.h"
97 "Map.MaxElementSize() != 1"));
100 "Map.ConstantElementSize() != true"));
106 values_.resize(MyLength_ * RowSize_);
121 return(GlobalLength_);
133 assert (ID <= RowSize_);
134 return(values_[LEID * RowSize_ + ID]);
137 inline T&
operator()(
const int GEID,
const int ID,
const bool isLocal)
139 int LEID =
Map().
LID(GEID);
141 assert (ID <= RowSize_);
142 return(values_[LEID * RowSize_ + ID]);
148 os <<
"DistArray object, label = " << this->
Label() << std::endl;
153 for (
int iproc=0; iproc <
Comm().
NumProc(); iproc++)
158 for (
int i = 0; i <
RowSize(); ++i) os <<
"V\t";
166 os <<
Map().
GID(i) <<
'\t';
167 for (
int j = 0; j < RowSize_; ++j)
168 os << values_[i * RowSize_ + j] <<
'\t';
179 if (count_ <
Map().NumMyElements())
180 return(
Map().GID(count_));
188 return(
Map().GID(0));
222 int * PermuteFromLIDs,
226 const DistArray& S =
dynamic_cast<const DistArray&
>(Source);
227 const std::vector<T>& From = S.ExtractView();
229 std::vector<T>& To = values_;
239 NumSameEntries = NumSameIDs;
242 if (To==From) NumSameEntries = 0;
247 for (j=0; j<NumSameEntries * RowSize_; j++)
254 if (NumPermuteIDs>0) {
256 for (j=0; j<NumPermuteIDs * RowSize_; j++)
257 To[PermuteToLIDs[j]] = From[PermuteFromLIDs[j]];
275 const std::vector<T>& From = S.ExtractView();
277 std::vector<T> To = values_;
282 SizeOfPacket = RowSize_ *
sizeof(T);
284 if(NumExportIDs*SizeOfPacket>LenExports) {
285 if (LenExports>0)
delete [] Exports;
286 LenExports = NumExportIDs*SizeOfPacket;
287 Exports =
new char[LenExports];
292 if (NumExportIDs>0) {
296 for (
int j=0; j<NumExportIDs; j++)
297 for (
int k = 0; k < RowSize_ ; ++k)
298 *ptr++ = From[ExportLIDs[j] * RowSize_ + k];
316 if (CombineMode != Insert)
319 std::cout << NumImportIDs << std::endl;
320 if (NumImportIDs<=0)
return(0);
331 for (j=0; j<NumImportIDs; j++)
332 for (
int k = 0; k < RowSize_ ; ++k)
333 To[ImportLIDs[j] * RowSize_ + k] = *ptr++;
342 std::vector<T> values_;
DistArray<T>: A class to store row-oriented multivectors of type T.
int MyLength() const
Returns the length of the locally owned array.
T * Values()
Returns a pointer to the internally stored data (non-const version).
T & operator()(const int GEID, const int ID, const bool isLocal)
int RowSize() const
Returns the row size, that is, the amount of data associated with each element.
int GlobalLength() const
Returns the global length of the array.
const T * Values() const
Returns a pointer to the internally stored data (const version).
void Print(std::ostream &os) const
Prints the array on the specified stream.
DistArray(const Epetra_Map &Map, const int RowSize)
Constructor for a given Map and RowSize.
T & operator()(const int LEID, const int ID)
Returns a reference to the ID component of the LEID local element.
const std::vector< T > & ExtractView() const
Extracts a view of the array.
int MaxElementSize() const
int NumGlobalElements() const
bool ConstantElementSize() const
int NumMyElements() const
virtual int NumProc() const=0
virtual int MyPID() const=0
const Epetra_BlockMap & Map() const
const Epetra_Comm & Comm() const
virtual const char * Label() const
EpetraExt::BlockCrsMatrix: A class for constructing a distributed block matrix.