EpetraExt Package Browser (Single Doxygen Collection) Development
Loading...
Searching...
No Matches
Public Member Functions | Private Member Functions | List of all members
EpetraExt_PointToBlockDiagPermute Class Reference

EpetraExt_PointToBlockDiagPermute: A class for managing point-to-block-diagonal permutations. More...

#include <EpetraExt_PointToBlockDiagPermute.h>

Inheritance diagram for EpetraExt_PointToBlockDiagPermute:
Inheritance graph
[legend]

Public Member Functions

 EpetraExt_PointToBlockDiagPermute (const Epetra_CrsMatrix &MAT)
 @ Name Constructors
 
- Public Member Functions inherited from Epetra_Operator
virtual ~Epetra_Operator ()
 
virtual int SetUseTranspose (bool UseTranspose)=0
 
virtual int Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0
 
virtual int ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0
 
virtual double NormInf () const=0
 
virtual const char * Label () const=0
 
virtual bool UseTranspose () const=0
 
virtual bool HasNormInf () const=0
 
virtual const Epetra_CommComm () const=0
 
virtual const Epetra_MapOperatorDomainMap () const=0
 
virtual const Epetra_MapOperatorRangeMap () const=0
 
- Public Member Functions inherited from Epetra_DistObject
 Epetra_DistObject (const Epetra_BlockMap &Map)
 
 Epetra_DistObject (const Epetra_BlockMap &Map, const char *const Label)
 
 Epetra_DistObject (const Epetra_DistObject &Source)
 
virtual ~Epetra_DistObject ()
 
int Import (const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 
int Import (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 
int Export (const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 
int Export (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 
const Epetra_BlockMapMap () const
 
const Epetra_CommComm () const
 
bool DistributedGlobal () const
 
virtual void Print (std::ostream &os) const
 
- Public Member Functions inherited from Epetra_Object
virtual void Print (std::ostream &os) const
 
virtual int ReportError (const std::string Message, int ErrorCode) const
 
 Epetra_Object (int TracebackModeIn=-1, bool set_label=true)
 
 Epetra_Object (const char *const Label, int TracebackModeIn=-1)
 
 Epetra_Object (const Epetra_Object &Object)
 
virtual ~Epetra_Object ()
 
virtual void SetLabel (const char *const Label)
 
virtual const char * Label () const
 
- Public Member Functions inherited from Epetra_SrcDistObject
virtual ~Epetra_SrcDistObject ()
 
virtual const Epetra_BlockMapMap () const=0
 

Private Member Functions

template<>
const int * Blockids_const_ptr () const
 
template<>
int *& Blockids_ref ()
 
template<>
const long long * Blockids_const_ptr () const
 
template<>
long long *& Blockids_ref ()
 

Internal utilities

Teuchos::ParameterList List_
 
const Epetra_CrsMatrixMatrix_
 
bool PurelyLocalMode_
 
bool ContiguousBlockMode_
 
int ContiguousBlockSize_
 
int NumBlocks_
 
int * Blockstart_
 
int * Blockids_int_
 
long long * Blockids_LL_
 
Epetra_BlockMapBDMap_
 
Epetra_MapCompatibleMap_
 
EpetraExt_BlockDiagMatrixBDMat_
 
Epetra_ImportImporter_
 
Epetra_ExportExporter_
 
Epetra_MultiVectorImportVector_
 
Epetra_MultiVectorExportVector_
 
virtual int CheckSizes (const Epetra_SrcDistObject &Source)
 Allows the source and target (this) objects to be compared for compatibility, return nonzero if not.
 
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.
 
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 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().
 
int ExtractBlockDiagonal ()
 Pulls the block diagonal of the matrix and then builds the BDMat_.
 
int SetupContiguousMode ()
 Setup/Cleanup for Contiguous Mode.
 
int CleanupContiguousMode ()
 
void UpdateImportVector (int NumVectors) const
 
void UpdateExportVector (int NumVectors) const
 
template<typename int_type >
Epetra_FECrsMatrixTCreateFECrsMatrix ()
 
template<typename int_type >
int TSetupContiguousMode ()
 
template<typename int_type >
int TExtractBlockDiagonal ()
 
template<typename int_type >
int TSetParameters (Teuchos::ParameterList &List)
 
template<typename int_type >
const int_type * Blockids_const_ptr () const
 
template<typename int_type >
int_type *& Blockids_ref ()
 

Destructor

virtual ~EpetraExt_PointToBlockDiagPermute ()
 Destructor.
 

Attribute set methods

virtual int SetParameters (Teuchos::ParameterList &List)
 Sets the parameter list.
 
virtual int SetUseTranspose (bool)
 Set whether to use the transpose.
 
virtual int Compute ()
 Extracts the block-diagonal, builds maps, etc.
 

Mathematical functions

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.
 
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.
 
virtual double NormInf () const
 Returns the infinity norm of the global matrix - NOT IMPLEMENTED.
 

Attribute access functions

virtual const char * Label () const
 Return a string describing the operator.
 
virtual bool UseTranspose () const
 Return the current UseTranspose setting.
 
virtual bool HasNormInf () const
 Return true if the this object can provide an approximate Inf-norm, false otherwise.
 
virtual const Epetra_CommComm () const
 Return a pointer to the Epetra_Comm communicator associated with this operator.
 
virtual const Epetra_MapOperatorDomainMap () const
 Return the Epetra_Map object associated with the domain of this operator.
 
virtual const Epetra_MapOperatorRangeMap () const
 Return the Epetra_Map object associated with the range of this operator.
 
virtual const EpetraExt_BlockDiagMatrixBlockMatrix ()
 Return the block matrix. Only call this after calling Compute.
 
virtual Epetra_FECrsMatrixCreateFECrsMatrix ()
 Create an Epetra_FECrsMatrix from the BlockDiagMatrix.
 

Miscellaneous

virtual void Print (std::ostream &os) const
 Print information about this object to the given output stream.
 

Import/Export Methods

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 Import (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 Imports an Epetra_DistObject using the Epetra_Export object.
 
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.
 
int Export (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 Exports an Epetra_DistObject using the Epetra_Export object.
 

Additional Inherited Members

- Static Public Member Functions inherited from Epetra_Object
static void SetTracebackMode (int TracebackModeValue)
 
static int GetTracebackMode ()
 
static std::ostream & GetTracebackStream ()
 
- Static Public Attributes inherited from Epetra_Object
static int TracebackMode
 
- Protected Member Functions inherited from Epetra_DistObject
virtual int CheckSizes (const Epetra_SrcDistObject &Source)=0
 
virtual int CopyAndPermute (const Epetra_SrcDistObject &Source, int NumSameIDs, int NumPermuteIDs, int *PermuteToLIDs, int *PermuteFromLIDs, const Epetra_OffsetIndex *Indexor, Epetra_CombineMode CombineMode=Zero)=0
 
virtual int PackAndPrepare (const Epetra_SrcDistObject &Source, int NumExportIDs, int *ExportLIDs, int &LenExports, char *&Exports, int &SizeOfPacket, int *Sizes, bool &VarSizes, Epetra_Distributor &Distor)=0
 
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)=0
 
virtual int DoTransfer (const Epetra_SrcDistObject &A, Epetra_CombineMode CombineMode, int NumSameIDs, int NumPermuteIDs, int NumRemoteIDs, int NumExportIDs, int *PermuteToLIDs, int *PermuteFromLIDs, int *RemoteLIDs, int *ExportLIDs, int &LenExports, char *&Exports, int &LenImports, char *&Imports, Epetra_Distributor &Distor, bool DoReverse, const Epetra_OffsetIndex *Indexor)
 
- Protected Member Functions inherited from Epetra_Object
std::string toString (const int &x) const
 
std::string toString (const long long &x) const
 
std::string toString (const double &x) const
 
- Protected Attributes inherited from Epetra_DistObject
Epetra_BlockMap Map_
 
const Epetra_CommComm_
 
char * Exports_
 
char * Imports_
 
int LenExports_
 
int LenImports_
 
int * Sizes_
 

Detailed Description

EpetraExt_PointToBlockDiagPermute: A class for managing point-to-block-diagonal permutations.

Manages point-to-block-diagonal permutations (and vice versa) as well as service routines for extracting block diagonals from matrices.

Definition at line 72 of file EpetraExt_PointToBlockDiagPermute.h.

Constructor & Destructor Documentation

◆ EpetraExt_PointToBlockDiagPermute()

EpetraExt_PointToBlockDiagPermute::EpetraExt_PointToBlockDiagPermute ( const Epetra_CrsMatrix MAT)

@ Name Constructors

Constructor

Definition at line 58 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ ~EpetraExt_PointToBlockDiagPermute()

EpetraExt_PointToBlockDiagPermute::~EpetraExt_PointToBlockDiagPermute ( )
virtual

Destructor.

Definition at line 83 of file EpetraExt_PointToBlockDiagPermute.cpp.

Member Function Documentation

◆ SetParameters()

int EpetraExt_PointToBlockDiagPermute::SetParameters ( Teuchos::ParameterList &  List)
virtual

Sets the parameter list.

Definition at line 137 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ SetUseTranspose()

virtual int EpetraExt_PointToBlockDiagPermute::SetUseTranspose ( bool  )
inlinevirtual

Set whether to use the transpose.

Returns
0 if this class can change its transpose state, else nonzero.

This class does NOT know how to apply its transpose, so this method always returns an error code.

Implements Epetra_Operator.

Definition at line 100 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Compute()

int EpetraExt_PointToBlockDiagPermute::Compute ( )
virtual

Extracts the block-diagonal, builds maps, etc.

Definition at line 155 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ Apply()

int EpetraExt_PointToBlockDiagPermute::Apply ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Returns the result of a Epetra_Operator applied to a Epetra_MultiVector X in Y.

Parameters
InX - A Epetra_MultiVector of dimension NumVectors to multiply with matrix.
OutY -A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_Operator.

Definition at line 162 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ ApplyInverse()

int EpetraExt_PointToBlockDiagPermute::ApplyInverse ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Returns the result of a Epetra_Operator inverse applied to an Epetra_MultiVector X in Y.

Parameters
InX - A Epetra_MultiVector of dimension NumVectors to solve for.
OutY -A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.
Warning
In order to work with AztecOO, any implementation of this method must support the case where X and Y are the same object.

Implements Epetra_Operator.

Definition at line 169 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ NormInf()

virtual double EpetraExt_PointToBlockDiagPermute::NormInf ( ) const
inlinevirtual

Returns the infinity norm of the global matrix - NOT IMPLEMENTED.

Implements Epetra_Operator.

Definition at line 136 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Label()

virtual const char * EpetraExt_PointToBlockDiagPermute::Label ( ) const
inlinevirtual

Return a string describing the operator.

Implements Epetra_Operator.

Definition at line 143 of file EpetraExt_PointToBlockDiagPermute.h.

◆ UseTranspose()

virtual bool EpetraExt_PointToBlockDiagPermute::UseTranspose ( ) const
inlinevirtual

Return the current UseTranspose setting.

Implements Epetra_Operator.

Definition at line 146 of file EpetraExt_PointToBlockDiagPermute.h.

◆ HasNormInf()

virtual bool EpetraExt_PointToBlockDiagPermute::HasNormInf ( ) const
inlinevirtual

Return true if the this object can provide an approximate Inf-norm, false otherwise.

Implements Epetra_Operator.

Definition at line 149 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Comm()

virtual const Epetra_Comm & EpetraExt_PointToBlockDiagPermute::Comm ( ) const
inlinevirtual

Return a pointer to the Epetra_Comm communicator associated with this operator.

Implements Epetra_Operator.

Definition at line 152 of file EpetraExt_PointToBlockDiagPermute.h.

◆ OperatorDomainMap()

virtual const Epetra_Map & EpetraExt_PointToBlockDiagPermute::OperatorDomainMap ( ) const
inlinevirtual

Return the Epetra_Map object associated with the domain of this operator.

Implements Epetra_Operator.

Definition at line 155 of file EpetraExt_PointToBlockDiagPermute.h.

◆ OperatorRangeMap()

virtual const Epetra_Map & EpetraExt_PointToBlockDiagPermute::OperatorRangeMap ( ) const
inlinevirtual

Return the Epetra_Map object associated with the range of this operator.

Implements Epetra_Operator.

Definition at line 158 of file EpetraExt_PointToBlockDiagPermute.h.

◆ BlockMatrix()

virtual const EpetraExt_BlockDiagMatrix & EpetraExt_PointToBlockDiagPermute::BlockMatrix ( )
inlinevirtual

Return the block matrix. Only call this after calling Compute.

Definition at line 161 of file EpetraExt_PointToBlockDiagPermute.h.

◆ CreateFECrsMatrix()

Epetra_FECrsMatrix * EpetraExt_PointToBlockDiagPermute::CreateFECrsMatrix ( )
virtual

Create an Epetra_FECrsMatrix from the BlockDiagMatrix.

This is generally only useful if you want to do a matrix-matrix multiply.

Definition at line 602 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ Print()

void EpetraExt_PointToBlockDiagPermute::Print ( std::ostream &  os) const
virtual

Print information about this object to the given output stream.

Reimplemented from Epetra_DistObject.

Definition at line 221 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ Import() [1/2]

int EpetraExt_PointToBlockDiagPermute::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.

Parameters
InSource - Distributed object that will be imported into the "\e this" object.
InImporter - A Epetra_Import object specifying the communication required.
InCombineMode - A Epetra_CombineMode enumerated type specifying how results should be combined on the receiving processor.
Returns
Integer error code, set to 0 if successful.

Definition at line 651 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ Import() [2/2]

int EpetraExt_PointToBlockDiagPermute::Import ( const Epetra_SrcDistObject A,
const Epetra_Export Exporter,
Epetra_CombineMode  CombineMode,
const Epetra_OffsetIndex Indexor = 0 
)

Imports an Epetra_DistObject using the Epetra_Export object.

Parameters
InSource - Distributed object that will be imported into the "\e this" object.
InExporter - A Epetra_Export object specifying the communication required.
InCombineMode - A Epetra_CombineMode enumerated type specifying how results should be combined on the receiving processor.
Returns
Integer error code, set to 0 if successful.

Definition at line 656 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ Export() [1/2]

int EpetraExt_PointToBlockDiagPermute::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.

Parameters
InSource - Distributed object that will be exported to the "\e this" object.
InImporter - A Epetra_Import object specifying the communication required.
InCombineMode - A Epetra_CombineMode enumerated type specifying how results should be combined on the receiving processor.
Returns
Integer error code, set to 0 if successful.

Definition at line 661 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ Export() [2/2]

int EpetraExt_PointToBlockDiagPermute::Export ( const Epetra_SrcDistObject A,
const Epetra_Export Exporter,
Epetra_CombineMode  CombineMode,
const Epetra_OffsetIndex Indexor = 0 
)

Exports an Epetra_DistObject using the Epetra_Export object.

Parameters
InSource - Distributed object that will be exported to the "\e this" multivector.
InExporter - A Epetra_Export object specifying the communication required.
InCombineMode - A Epetra_CombineMode enumerated type specifying how results should be combined on the receiving processor.
Returns
Integer error code, set to 0 if successful.

Definition at line 666 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ CheckSizes()

int EpetraExt_PointToBlockDiagPermute::CheckSizes ( const Epetra_SrcDistObject Source)
protectedvirtual

Allows the source and target (this) objects to be compared for compatibility, return nonzero if not.

Implements Epetra_DistObject.

Definition at line 672 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ CopyAndPermute()

int EpetraExt_PointToBlockDiagPermute::CopyAndPermute ( const Epetra_SrcDistObject Source,
int  NumSameIDs,
int  NumPermuteIDs,
int *  PermuteToLIDs,
int *  PermuteFromLIDs,
const Epetra_OffsetIndex Indexor,
Epetra_CombineMode  CombineMode = Zero 
)
protectedvirtual

Perform ID copies and permutations that are on processor.

Implements Epetra_DistObject.

Definition at line 678 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ PackAndPrepare()

int EpetraExt_PointToBlockDiagPermute::PackAndPrepare ( const Epetra_SrcDistObject Source,
int  NumExportIDs,
int *  ExportLIDs,
int &  LenExports,
char *&  Exports,
int &  SizeOfPacket,
int *  Sizes,
bool &  VarSizes,
Epetra_Distributor Distor 
)
protectedvirtual

Perform any packing or preparation required for call to DoTransfer().

Implements Epetra_DistObject.

Definition at line 690 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ UnpackAndCombine()

int EpetraExt_PointToBlockDiagPermute::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 
)
protectedvirtual

Perform any unpacking and combining after call to DoTransfer().

Implements Epetra_DistObject.

Definition at line 704 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ ExtractBlockDiagonal()

int EpetraExt_PointToBlockDiagPermute::ExtractBlockDiagonal ( )
private

Pulls the block diagonal of the matrix and then builds the BDMat_.

Definition at line 489 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ SetupContiguousMode()

int EpetraExt_PointToBlockDiagPermute::SetupContiguousMode ( )
private

Setup/Cleanup for Contiguous Mode.

Definition at line 538 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ CleanupContiguousMode()

int EpetraExt_PointToBlockDiagPermute::CleanupContiguousMode ( )
private

Definition at line 555 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ UpdateImportVector()

void EpetraExt_PointToBlockDiagPermute::UpdateImportVector ( int  NumVectors) const
private

Definition at line 619 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ UpdateExportVector()

void EpetraExt_PointToBlockDiagPermute::UpdateExportVector ( int  NumVectors) const
private

Definition at line 633 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ TCreateFECrsMatrix()

template<typename int_type >
Epetra_FECrsMatrix * EpetraExt_PointToBlockDiagPermute::TCreateFECrsMatrix
private

Definition at line 570 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ TSetupContiguousMode()

template<typename int_type >
int EpetraExt_PointToBlockDiagPermute::TSetupContiguousMode
private

Definition at line 507 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ TExtractBlockDiagonal()

template<typename int_type >
int EpetraExt_PointToBlockDiagPermute::TExtractBlockDiagonal
private

Definition at line 230 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ TSetParameters()

template<typename int_type >
int EpetraExt_PointToBlockDiagPermute::TSetParameters ( Teuchos::ParameterList &  List)
private

Definition at line 97 of file EpetraExt_PointToBlockDiagPermute.cpp.

◆ Blockids_const_ptr() [1/3]

template<typename int_type >
const int_type * EpetraExt_PointToBlockDiagPermute::Blockids_const_ptr ( ) const
private

◆ Blockids_ref() [1/3]

template<typename int_type >
int_type *& EpetraExt_PointToBlockDiagPermute::Blockids_ref ( )
private

◆ Blockids_const_ptr() [2/3]

template<>
const int * EpetraExt_PointToBlockDiagPermute::Blockids_const_ptr ( ) const
inlineprivate

Definition at line 333 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Blockids_ref() [2/3]

template<>
int *& EpetraExt_PointToBlockDiagPermute::Blockids_ref ( )
inlineprivate

Definition at line 335 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Blockids_const_ptr() [3/3]

template<>
const long long * EpetraExt_PointToBlockDiagPermute::Blockids_const_ptr ( ) const
inlineprivate

Definition at line 338 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Blockids_ref() [3/3]

template<>
long long *& EpetraExt_PointToBlockDiagPermute::Blockids_ref ( )
inlineprivate

Definition at line 339 of file EpetraExt_PointToBlockDiagPermute.h.

Member Data Documentation

◆ List_

Teuchos::ParameterList EpetraExt_PointToBlockDiagPermute::List_
private

Definition at line 291 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Matrix_

const Epetra_CrsMatrix* EpetraExt_PointToBlockDiagPermute::Matrix_
private

Definition at line 292 of file EpetraExt_PointToBlockDiagPermute.h.

◆ PurelyLocalMode_

bool EpetraExt_PointToBlockDiagPermute::PurelyLocalMode_
private

Definition at line 293 of file EpetraExt_PointToBlockDiagPermute.h.

◆ ContiguousBlockMode_

bool EpetraExt_PointToBlockDiagPermute::ContiguousBlockMode_
private

Definition at line 296 of file EpetraExt_PointToBlockDiagPermute.h.

◆ ContiguousBlockSize_

int EpetraExt_PointToBlockDiagPermute::ContiguousBlockSize_
private

Definition at line 297 of file EpetraExt_PointToBlockDiagPermute.h.

◆ NumBlocks_

int EpetraExt_PointToBlockDiagPermute::NumBlocks_
private

Definition at line 299 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Blockstart_

int* EpetraExt_PointToBlockDiagPermute::Blockstart_
private

Definition at line 300 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Blockids_int_

int* EpetraExt_PointToBlockDiagPermute::Blockids_int_
private

Definition at line 301 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Blockids_LL_

long long* EpetraExt_PointToBlockDiagPermute::Blockids_LL_
private

Definition at line 303 of file EpetraExt_PointToBlockDiagPermute.h.

◆ BDMap_

Epetra_BlockMap* EpetraExt_PointToBlockDiagPermute::BDMap_
private

Definition at line 305 of file EpetraExt_PointToBlockDiagPermute.h.

◆ CompatibleMap_

Epetra_Map* EpetraExt_PointToBlockDiagPermute::CompatibleMap_
private

Definition at line 306 of file EpetraExt_PointToBlockDiagPermute.h.

◆ BDMat_

EpetraExt_BlockDiagMatrix* EpetraExt_PointToBlockDiagPermute::BDMat_
private

Definition at line 307 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Importer_

Epetra_Import* EpetraExt_PointToBlockDiagPermute::Importer_
private

Definition at line 308 of file EpetraExt_PointToBlockDiagPermute.h.

◆ Exporter_

Epetra_Export* EpetraExt_PointToBlockDiagPermute::Exporter_
private

Definition at line 309 of file EpetraExt_PointToBlockDiagPermute.h.

◆ ImportVector_

Epetra_MultiVector* EpetraExt_PointToBlockDiagPermute::ImportVector_
mutableprivate

Definition at line 310 of file EpetraExt_PointToBlockDiagPermute.h.

◆ ExportVector_

Epetra_MultiVector* EpetraExt_PointToBlockDiagPermute::ExportVector_
mutableprivate

Definition at line 311 of file EpetraExt_PointToBlockDiagPermute.h.


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