42#ifndef EPETRAEXT_POINTTOBLOCKDIAGPERMUTE_H
43#define EPETRAEXT_POINTTOBLOCKDIAGPERMUTE_H
53#include "Teuchos_ParameterList.hpp"
143 virtual const char *
Label()
const{
return "Fix Me";}
172 virtual void Print(std::ostream& os)
const;
251 int * PermuteFromLIDs,
302#ifndef EPETRA_NO_64BIT_GLOBAL_INDICES
313 template<
typename int_type>
316 template<
typename int_type>
319 template<
typename int_type>
322 template<
typename int_type>
325 template<
typename int_type>
328 template<
typename int_type>
333template<>
inline const int* EpetraExt_PointToBlockDiagPermute::Blockids_const_ptr<int>()
const {
return Blockids_int_; }
335template<>
inline int*& EpetraExt_PointToBlockDiagPermute::Blockids_ref<int>() {
return Blockids_int_; }
337#ifndef EPETRA_NO_64BIT_GLOBAL_INDICES
338template<>
inline const long long* EpetraExt_PointToBlockDiagPermute::Blockids_const_ptr<long long>()
const {
return Blockids_LL_; }
339template<>
inline long long*& EpetraExt_PointToBlockDiagPermute::Blockids_ref<long long>() {
return Blockids_LL_; }
EpetraExt_BlockDiagMatrix: A class for storing distributed block matrices.
EpetraExt_PointToBlockDiagPermute: A class for managing point-to-block-diagonal permutations.
bool ContiguousBlockMode_
virtual bool HasNormInf() const
Return true if the this object can provide an approximate Inf-norm, false otherwise.
const Epetra_CrsMatrix * Matrix_
virtual double NormInf() const
Returns the infinity norm of the global matrix - NOT IMPLEMENTED.
EpetraExt_BlockDiagMatrix * BDMat_
Teuchos::ParameterList List_
int TSetupContiguousMode()
virtual const Epetra_Map & OperatorDomainMap() const
Return the Epetra_Map object associated with the domain of this operator.
virtual void Print(std::ostream &os) const
Print information about this object to the given output stream.
virtual const Epetra_Comm & Comm() const
Return a pointer to the Epetra_Comm communicator associated with this operator.
virtual int PackAndPrepare(const Epetra_SrcDistObject &Source, int NumExportIDs, int *ExportLIDs, int &LenExports, char *&Exports, int &SizeOfPacket, int *Sizes, bool &VarSizes, Epetra_Distributor &Distor)
Perform any packing or preparation required for call to DoTransfer().
virtual const char * Label() const
Return a string describing the operator.
virtual ~EpetraExt_PointToBlockDiagPermute()
Destructor.
virtual Epetra_FECrsMatrix * CreateFECrsMatrix()
Create an Epetra_FECrsMatrix from the BlockDiagMatrix.
EpetraExt_PointToBlockDiagPermute(const Epetra_CrsMatrix &MAT)
@ Name Constructors
int TExtractBlockDiagonal()
virtual int CopyAndPermute(const Epetra_SrcDistObject &Source, int NumSameIDs, int NumPermuteIDs, int *PermuteToLIDs, int *PermuteFromLIDs, const Epetra_OffsetIndex *Indexor, Epetra_CombineMode CombineMode=Zero)
Perform ID copies and permutations that are on processor.
void UpdateExportVector(int NumVectors) const
int ExtractBlockDiagonal()
Pulls the block diagonal of the matrix and then builds the BDMat_.
int SetupContiguousMode()
Setup/Cleanup for Contiguous Mode.
virtual bool UseTranspose() const
Return the current UseTranspose setting.
virtual const EpetraExt_BlockDiagMatrix & BlockMatrix()
Return the block matrix. Only call this after calling Compute.
int TSetParameters(Teuchos::ParameterList &List)
virtual int UnpackAndCombine(const Epetra_SrcDistObject &Source, int NumImportIDs, int *ImportLIDs, int LenImports, char *Imports, int &SizeOfPacket, Epetra_Distributor &Distor, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor)
Perform any unpacking and combining after call to DoTransfer().
virtual int SetParameters(Teuchos::ParameterList &List)
Sets the parameter list.
Epetra_MultiVector * ExportVector_
virtual int SetUseTranspose(bool)
Set whether to use the transpose.
virtual int Apply(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
Returns the result of a Epetra_Operator applied to a Epetra_MultiVector X in Y.
Epetra_Export * Exporter_
virtual int ApplyInverse(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
Returns the result of a Epetra_Operator inverse applied to an Epetra_MultiVector X in Y.
const int_type * Blockids_const_ptr() const
Epetra_Map * CompatibleMap_
virtual const Epetra_Map & OperatorRangeMap() const
Return the Epetra_Map object associated with the range of this operator.
void UpdateImportVector(int NumVectors) const
int Export(const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
Exports an Epetra_DistObject using the Epetra_Import object.
virtual int Compute()
Extracts the block-diagonal, builds maps, etc.
Epetra_FECrsMatrix * TCreateFECrsMatrix()
int CleanupContiguousMode()
Epetra_MultiVector * ImportVector_
virtual int CheckSizes(const Epetra_SrcDistObject &Source)
Allows the source and target (this) objects to be compared for compatibility, return nonzero if not.
Epetra_Import * Importer_
int Import(const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
Imports an Epetra_DistObject using the Epetra_Import object.
int_type *& Blockids_ref()
const Epetra_BlockMap & Map() const