Epetra  Development
 All Classes Namespaces Files Functions Variables Enumerations Enumerator Pages
Public Member Functions | List of all members
Epetra_MpiSmpComm Class Reference

Epetra_MpiSmpComm: The Epetra MPI Shared Memory Parallel Communication Class. More...

#include <Epetra_MpiSmpComm.h>

Inheritance diagram for Epetra_MpiSmpComm:
Inheritance graph
[legend]
Collaboration diagram for Epetra_MpiSmpComm:
Collaboration graph
[legend]

Public Member Functions

Epetra_MpiSmpCommoperator= (const Epetra_MpiSmpComm &Comm)
 Assignment Operator.
 
Constructor/Destructor Methods
 Epetra_MpiSmpComm (MPI_Comm comm)
 Epetra_MpiSmpComm MPI Constructor. More...
 
 Epetra_MpiSmpComm (const Epetra_MpiSmpComm &Comm)
 Epetra_MpiSmpComm Copy Constructor. More...
 
Epetra_CommClone () const
 Clone method.
 
virtual ~Epetra_MpiSmpComm ()
 Epetra_MpiSmpComm Destructor. More...
 
Barrier Methods
void Barrier () const
 Epetra_MpiSmpComm Barrier function. More...
 
Broadcast Methods
int Broadcast (double *MyVals, int Count, int Root) const
 Epetra_MpiSmpComm Broadcast function. More...
 
int Broadcast (int *MyVals, int Count, int Root) const
 Epetra_MpiSmpComm Broadcast function. More...
 
int Broadcast (long *MyVals, int Count, int Root) const
 Epetra_MpiSmpComm Broadcast function. More...
 
int Broadcast (char *MyVals, int Count, int Root) const
 Epetra_MpiSmpComm Broadcast function. More...
 
Gather Methods
int GatherAll (double *MyVals, double *AllVals, int Count) const
 Epetra_MpiSmpComm All Gather function. More...
 
int GatherAll (int *MyVals, int *AllVals, int Count) const
 Epetra_MpiSmpComm All Gather function. More...
 
int GatherAll (long *MyVals, long *AllVals, int Count) const
 Epetra_MpiSmpComm All Gather function. More...
 
Sum Methods
int SumAll (double *PartialSums, double *GlobalSums, int Count) const
 Epetra_MpiSmpComm Global Sum function. More...
 
int SumAll (int *PartialSums, int *GlobalSums, int Count) const
 Epetra_MpiSmpComm Global Sum function. More...
 
int SumAll (long *PartialSums, long *GlobalSums, int Count) const
 Epetra_MpiSmpComm Global Sum function. More...
 
Max/Min Methods
int MaxAll (double *PartialMaxs, double *GlobalMaxs, int Count) const
 Epetra_MpiSmpComm Global Max function. More...
 
int MaxAll (int *PartialMaxs, int *GlobalMaxs, int Count) const
 Epetra_MpiSmpComm Global Max function. More...
 
int MaxAll (long *PartialMaxs, long *GlobalMaxs, int Count) const
 Epetra_MpiSmpComm Global Max function. More...
 
int MinAll (double *PartialMins, double *GlobalMins, int Count) const
 Epetra_MpiSmpComm Global Min function. More...
 
int MinAll (int *PartialMins, int *GlobalMins, int Count) const
 Epetra_MpiSmpComm Global Min function. More...
 
int MinAll (long *PartialMins, long *GlobalMins, int Count) const
 Epetra_MpiSmpComm Global Min function. More...
 
Parallel Prefix Methods
int ScanSum (double *MyVals, double *ScanSums, int Count) const
 Epetra_MpiSmpComm Scan Sum function. More...
 
int ScanSum (int *MyVals, int *ScanSums, int Count) const
 Epetra_MpiSmpComm Scan Sum function. More...
 
int ScanSum (long *MyVals, long *ScanSums, int Count) const
 Epetra_MpiSmpComm Scan Sum function. More...
 
Attribute Accessor Methods
MPI_Comm Comm () const
 Extract MPI Communicator from a Epetra_MpiSmpComm object.
 
int MyPID () const
 Return my process ID. More...
 
int NumProc () const
 Returns total number of processes. More...
 
Gather/Scatter and Directory Constructors
Epetra_DistributorCreateDistributor () const
 Create a distributor object.
 
Epetra_DirectoryCreateDirectory (const Epetra_BlockMap &Map) const
 Create a directory object for the given Epetra_BlockMap.
 
MPI-specific Methods
int GetMpiTag () const
 Acquire an MPI tag from the Epetra range of 24050-24099, increment tag.
 
MPI_Comm GetMpiComm () const
 Acquire an MPI tag from the Epetra range of 24050-24099, increment tag.
 
Experimental SMP cluster methods (not rigorously implemented)
void NodeBarrier () const
 Epetra_MpiSmpComm Node Barrier function. More...
 
int MyThreadID () const
 Return my thread ID. More...
 
int MyNodeID () const
 Return my node ID. More...
 
int SetNumThreads (int NumThreads)
 Set number of threads on this node. More...
 
int NumThreads () const
 Get number of threads on this node. More...
 
int SetMyThreadID (int ThreadID)
 Set my thread ID. More...
 
int SetMyNodeID (int NodeID)
 Set my node ID. More...
 
Print object to an output stream
void Print (std::ostream &os) const
 Print method that implements Epetra_Object virtual Print method.
 
void PrintInfo (std::ostream &os) const
 Print method that implements Epetra_Comm virtual PrintInfo method.
 
- Public Member Functions inherited from Epetra_Object
 Epetra_Object (int TracebackModeIn=-1, bool set_label=true)
 Epetra_Object Constructor. More...
 
 Epetra_Object (const char *const Label, int TracebackModeIn=-1)
 Epetra_Object Constructor. More...
 
 Epetra_Object (const Epetra_Object &Object)
 Epetra_Object Copy Constructor. More...
 
virtual ~Epetra_Object ()
 Epetra_Object Destructor. More...
 
virtual int ReportError (const std::string Message, int ErrorCode) const
 Error reporting method.
 
virtual void SetLabel (const char *const Label)
 Epetra_Object Label definition using char *. More...
 
virtual const char * Label () const
 Epetra_Object Label access funtion. More...
 
- Public Member Functions inherited from Epetra_Comm
virtual ~Epetra_Comm ()
 Epetra_Comm Destructor.
 
virtual int Broadcast (long long *MyVals, int Count, int Root) const =0
 Epetra_Comm Broadcast function. More...
 
virtual int GatherAll (long long *MyVals, long long *AllVals, int Count) const =0
 Epetra_Comm All Gather function. More...
 
virtual int SumAll (long long *PartialSums, long long *GlobalSums, int Count) const =0
 Epetra_Comm Global Sum function. More...
 
virtual int MaxAll (long long *PartialMaxs, long long *GlobalMaxs, int Count) const =0
 Epetra_Comm Global Max function. More...
 
virtual int MinAll (long long *PartialMins, long long *GlobalMins, int Count) const =0
 
virtual int ScanSum (long long *MyVals, long long *ScanSums, int Count) const =0
 Epetra_Comm Scan Sum function. More...
 

Additional Inherited Members

- Static Public Member Functions inherited from Epetra_Object
static void SetTracebackMode (int TracebackModeValue)
 Set the value of the Epetra_Object error traceback report mode. More...
 
static int GetTracebackMode ()
 Get the value of the Epetra_Object error report mode.
 
static std::ostream & GetTracebackStream ()
 Get the output stream for error reporting.
 
- Static Public Attributes inherited from Epetra_Object
static int TracebackMode
 
- 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
 

Detailed Description

Epetra_MpiSmpComm: The Epetra MPI Shared Memory Parallel Communication Class.

The Epetra_MpiSmpComm class is an implementation of Epetra_Comm that encapsulates the general information and services needed for other Epetra classes to run on a parallel computer using MPI and shared memory threads.

Warning
This is an experimental class that marginally supported nested share memory parallelism within MPI processes.
This class has been deprecated.

Constructor & Destructor Documentation

Epetra_MpiSmpComm::Epetra_MpiSmpComm ( MPI_Comm  comm)

Epetra_MpiSmpComm MPI Constructor.

Creates a Epetra_MpiSmpComm instance for use with MPI. If no specialized MPI communicator is needed, this constuctor can be called with the argument MPI_COMM_WORLD.

Epetra_MpiSmpComm::Epetra_MpiSmpComm ( const Epetra_MpiSmpComm Comm)

Epetra_MpiSmpComm Copy Constructor.

Makes an exact copy of an existing Epetra_MpiSmpComm instance.

virtual Epetra_MpiSmpComm::~Epetra_MpiSmpComm ( )
virtual

Epetra_MpiSmpComm Destructor.

Completely deletes a Epetra_MpiSmpComm object.

Warning
Note: All objects that depend on a Epetra_MpiSmpComm instance should be destroyed prior to calling this function.

Member Function Documentation

void Epetra_MpiSmpComm::Barrier ( ) const
virtual

Epetra_MpiSmpComm Barrier function.

Causes each processor in the communicator to wait until all processors have arrived.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::Broadcast ( double *  MyVals,
int  Count,
int  Root 
) const
virtual

Epetra_MpiSmpComm Broadcast function.

Takes list of input values from the root processor and sends to all other processors.

Parameters
ValuesInOut On entry, the root processor contains the list of values. On exit, all processors will have the same list of values. Note that values must be allocated on all processor before the broadcast.
CountIn On entry, contains the length of the list of Values.
RootIn On entry, contains the processor from which all processors will receive a copy of Values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::Broadcast ( int *  MyVals,
int  Count,
int  Root 
) const
virtual

Epetra_MpiSmpComm Broadcast function.

Take list of input values from the root processor and sends to all other processors.

Parameters
ValuesInOut On entry, the root processor contains the list of values. On exit, all processors will have the same list of values. Note that values must be allocated on all processor before the broadcast.
CountIn On entry, contains the length of the list of Values.
RootIn On entry, contains the processor from which all processors will receive a copy of Values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::Broadcast ( long *  MyVals,
int  Count,
int  Root 
) const
virtual

Epetra_MpiSmpComm Broadcast function.

Take list of input values from the root processor and sends to all other processors.

Parameters
ValuesInOut On entry, the root processor contains the list of values. On exit, all processors will have the same list of values. Note that values must be allocated on all processor before the broadcast.
CountIn On entry, contains the length of the list of Values.
RootIn On entry, contains the processor from which all processors will receive a copy of Values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::Broadcast ( char *  MyVals,
int  Count,
int  Root 
) const
virtual

Epetra_MpiSmpComm Broadcast function.

Takes list of input values from the root processor and sends to all other processors.

Parameters
ValuesInOut On entry, the root processor contains the list of values. On exit, all processors will have the same list of values. Note that values must be allocated on all processor before the broadcast.
CountIn On entry, contains the length of the list of Values.
RootIn On entry, contains the processor from which all processors will receive a copy of Values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::GatherAll ( double *  MyVals,
double *  AllVals,
int  Count 
) const
virtual

Epetra_MpiSmpComm All Gather function.

Take list of input values from all processors in the communicator and creates an ordered contiguous list of those values on each processor.

Parameters
MyValsIn On entry, contains the list of values, to be sent to all processors.
AllValsOut On exit, contains the list of values from all processors. Must by of size NumProc*Count.
CountIn On entry, contains the length of the list of MyVals.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::GatherAll ( int *  MyVals,
int *  AllVals,
int  Count 
) const
virtual

Epetra_MpiSmpComm All Gather function.

Take list of input values from all processors in the communicator and creates an ordered contiguous list of those values on each processor.

Parameters
MyValsIn On entry, contains the list of values, to be sent to all processors.
AllValsOut On exit, contains the list of values from all processors. Must by of size NumProc*Count.
CountIn On entry, contains the length of the list of MyVals.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::GatherAll ( long *  MyVals,
long *  AllVals,
int  Count 
) const
virtual

Epetra_MpiSmpComm All Gather function.

Take list of input values from all processors in the communicator and creates an ordered contiguous list of those values on each processor.

Parameters
MyValsIn On entry, contains the list of values, to be sent to all processors.
AllValsOut On exit, contains the list of values from all processors. Must by of size NumProc*Count.
CountIn On entry, contains the length of the list of MyVals.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::MaxAll ( double *  PartialMaxs,
double *  GlobalMaxs,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Max function.

Take list of input values from all processors in the communicator, computes the max and returns the max to all processors.

Parameters
PartialMaxsIn On entry, contains the list of values, usually partial maxs computed locally; using these Partial Maxs, the max across all processors will be computed.
GlobalMaxsOut On exit, contains the list of maxs computed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::MaxAll ( int *  PartialMaxs,
int *  GlobalMaxs,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Max function.

Take list of input values from all processors in the communicator, computes the max and returns the max to all processors.

Parameters
PartialMaxsIn On entry, contains the list of values, usually partial maxs computed locally; using these Partial Maxs, the max across all processors will be computed.
GlobalMaxsOut On exit, contains the list of maxs computed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::MaxAll ( long *  PartialMaxs,
long *  GlobalMaxs,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Max function.

Take list of input values from all processors in the communicator, computes the max and returns the max to all processors.

Parameters
PartialMaxsIn On entry, contains the list of values, usually partial maxs computed locally; using these Partial Maxs, the max across all processors will be computed.
GlobalMaxsOut On exit, contains the list of maxs computed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::MinAll ( double *  PartialMins,
double *  GlobalMins,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Min function.

Take list of input values from all processors in the communicator, computes the min and returns the min to all processors.

Parameters
PartialMinsIn On entry, contains the list of values, usually partial mins computed locally; using these Partial Mins, the min across all processors will be computed.
GlobalMinsOut On exit, contains the list of mins computed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::MinAll ( int *  PartialMins,
int *  GlobalMins,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Min function.

Take list of input values from all processors in the communicator, computes the max and returns the max to all processors.

Parameters
PartialMinsIn On entry, contains the list of values, usually partial mins computed locally; using these Partial Mins, the min across all processors will be computed.
GlobalMinsOut On exit, contains the list of mins computed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::MinAll ( long *  PartialMins,
long *  GlobalMins,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Min function.

Take list of input values from all processors in the communicator, computes the max and returns the max to all processors.

Parameters
PartialMinsIn On entry, contains the list of values, usually partial mins computed locally; using these Partial Mins, the min across all processors will be computed.
GlobalMinsOut On exit, contains the list of mins computed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::MyNodeID ( ) const
inline

Return my node ID.

If SetMyNodeD was called to set a node value, this function returns the thread ID of the calling process. Otherwise returns the same value as MyPID().

int Epetra_MpiSmpComm::MyPID ( ) const
inlinevirtual

Return my process ID.

In MPI mode returns the rank of the calling process. In serial mode returns 0.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::MyThreadID ( ) const
inline

Return my thread ID.

If SetMyThreadID was called to set a thread value, this function returns the thread ID of the calling process. Otherwise returns 0.

void Epetra_MpiSmpComm::NodeBarrier ( ) const

Epetra_MpiSmpComm Node Barrier function.

A no-op for a serial communicator. For MPI, it causes each process on a given node in the communicator to wait until all processes on that node have arrived.

This function can be used to select a subset of MPI processes that are associated with a group of threaded processes and synchronize only with this subset.

int Epetra_MpiSmpComm::NumProc ( ) const
inlinevirtual

Returns total number of processes.

In MPI mode returns the size of the MPI communicator. In serial mode returns 1.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::NumThreads ( ) const
inline

Get number of threads on this node.

Sets the number of threads on the node that owns the calling process. By default the number of threads is 1.

int Epetra_MpiSmpComm::ScanSum ( double *  MyVals,
double *  ScanSums,
int  Count 
) const
virtual

Epetra_MpiSmpComm Scan Sum function.

Take list of input values from all processors in the communicator, computes the scan sum and returns it to all processors such that processor i contains the sum of values from processor 0 up to and including processor i.

Parameters
MyValsIn On entry, contains the list of values to be summed across all processors.
ScanSumsOut On exit, contains the list of values summed across processors 0 through i.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::ScanSum ( int *  MyVals,
int *  ScanSums,
int  Count 
) const
virtual

Epetra_MpiSmpComm Scan Sum function.

Take list of input values from all processors in the communicator, computes the scan sum and returns it to all processors such that processor i contains the sum of values from processor 0 up to and including processor i.

Parameters
MyValsIn On entry, contains the list of values to be summed across all processors.
ScanSumsOut On exit, contains the list of values summed across processors 0 through i.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::ScanSum ( long *  MyVals,
long *  ScanSums,
int  Count 
) const
virtual

Epetra_MpiSmpComm Scan Sum function.

Take list of input values from all processors in the communicator, computes the scan sum and returns it to all processors such that processor i contains the sum of values from processor 0 up to and including processor i.

Parameters
MyValsIn On entry, contains the list of values to be summed across all processors.
ScanSumsOut On exit, contains the list of values summed across processors 0 through i.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::SetMyNodeID ( int  NodeID)
inline

Set my node ID.

Sets the node ID for the calling process. Can be used to facilitate threaded programming across an MPI application by associating several MPI processes with a single node. By default, each MPI process is associated with a single node with the same ID.

int Epetra_MpiSmpComm::SetMyThreadID ( int  ThreadID)
inline

Set my thread ID.

Sets the thread ID for the calling process. Can be used to facilitate threaded programming across an MPI application by allowing multiple MPI processes to be considered threads of a virtual shared memory process. Threads and nodes should be used together. By default the thread ID is zero.

int Epetra_MpiSmpComm::SetNumThreads ( int  NumThreads)
inline

Set number of threads on this node.

Sets the number of threads on the node that owns the calling process. By default the number of threads is 1.

int Epetra_MpiSmpComm::SumAll ( double *  PartialSums,
double *  GlobalSums,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Sum function.

Take list of input values from all processors in the communicator, computes the sum and returns the sum to all processors.

Parameters
PartialSumsIn On entry, contains the list of values, usually partial sums computed locally, to be summed across all processors.
GlobalSumsOut On exit, contains the list of values summed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::SumAll ( int *  PartialSums,
int *  GlobalSums,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Sum function.

Take list of input values from all processors in the communicator, computes the sum and returns the sum to all processors.

Parameters
PartialSumsIn On entry, contains the list of values, usually partial sums computed locally, to be summed across all processors.
GlobalSumsOut On exit, contains the list of values summed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.

int Epetra_MpiSmpComm::SumAll ( long *  PartialSums,
long *  GlobalSums,
int  Count 
) const
virtual

Epetra_MpiSmpComm Global Sum function.

Take list of input values from all processors in the communicator, computes the sum and returns the sum to all processors.

Parameters
PartialSumsIn On entry, contains the list of values, usually partial sums computed locally, to be summed across all processors.
GlobalSumsOut On exit, contains the list of values summed across all processors.
CountIn On entry, contains the length of the list of values.

Implements Epetra_Comm.


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