Epetra Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Functions
Epetra_Util.cpp File Reference
#include "Epetra_ConfigDefs.h"
#include "Epetra_Util.h"
#include "Epetra_Object.h"
#include "Epetra_Comm.h"
#include "Epetra_Directory.h"
#include "Epetra_Map.h"
#include "Epetra_LocalMap.h"
#include "Epetra_CrsGraph.h"
#include "Epetra_CrsMatrix.h"
#include "Epetra_MultiVector.h"
#include "Epetra_IntVector.h"
#include "Epetra_GIDTypeVector.h"
#include "Epetra_Import.h"
#include <limits>
Include dependency graph for Epetra_Util.cpp:

Go to the source code of this file.

Functions

template<typename int_type >
static Epetra_Map TCreate_Root_Map (const Epetra_Map &usermap, int root)
 
template<typename T >
int Epetra_Util_binary_search (T item, const T *list, int len, int &insertPoint)
 Utility function to perform a binary-search on a list of data. More...
 
int Epetra_Util_binary_search (int item, const int *list, int len, int &insertPoint)
 
int Epetra_Util_binary_search (long long item, const long long *list, int len, int &insertPoint)
 
template<typename T >
int Epetra_Util_binary_search_aux (T item, const int *list, const T *aux_list, int len, int &insertPoint)
 Utility function to perform a binary-search on a list of data. More...
 
int Epetra_Util_binary_search_aux (int item, const int *list, const int *aux_list, int len, int &insertPoint)
 
int Epetra_Util_binary_search_aux (long long item, const int *list, const long long *aux_list, int len, int &insertPoint)
 
int Epetra_Util_ExtractHbData (Epetra_CrsMatrix *A, Epetra_MultiVector *LHS, Epetra_MultiVector *RHS, int &M, int &N, int &nz, int *&ptr, int *&ind, double *&val, int &Nrhs, double *&rhs, int &ldrhs, double *&lhs, int &ldlhs)
 Harwell-Boeing data extraction routine. More...
 

Function Documentation

template<typename int_type >
static Epetra_Map TCreate_Root_Map ( const Epetra_Map usermap,
int  root 
)
static

Definition at line 281 of file Epetra_Util.cpp.

template<typename T >
int Epetra_Util_binary_search ( item,
const T *  list,
int  len,
int &  insertPoint 
)

Utility function to perform a binary-search on a list of data.

Important assumption: data is assumed to be sorted.

Parameters
itemto be searched for
listto be searched in
lenLength of list
insertPointInput/Output. If item is found, insertPoint is not referenced. If item is not found, insertPoint is set to the offset at which item should be inserted in list such that order (sortedness) would be maintained.
Returns
offset Location in list at which item was found. -1 if not found.

Definition at line 866 of file Epetra_Util.cpp.

int Epetra_Util_binary_search ( int  item,
const int *  list,
int  len,
int &  insertPoint 
)

Definition at line 898 of file Epetra_Util.cpp.

int Epetra_Util_binary_search ( long long  item,
const long long *  list,
int  len,
int &  insertPoint 
)

Definition at line 907 of file Epetra_Util.cpp.

template<typename T >
int Epetra_Util_binary_search_aux ( item,
const int *  list,
const T *  aux_list,
int  len,
int &  insertPoint 
)

Utility function to perform a binary-search on a list of data.

Important assumption: data is assumed to be sorted.

Parameters
itemto be searched for
listto be searched in
aux_list
lenLength of list
insertPointInput/Output. If item is found, insertPoint is not referenced. If item is not found, insertPoint is set to the offset at which item should be inserted in list such that order (sortedness) would be maintained.
Returns
offset Location in list at which aux_list[list[i]] item was found. -1 if not found.

Definition at line 917 of file Epetra_Util.cpp.

int Epetra_Util_binary_search_aux ( int  item,
const int *  list,
const int *  aux_list,
int  len,
int &  insertPoint 
)

Definition at line 951 of file Epetra_Util.cpp.

int Epetra_Util_binary_search_aux ( long long  item,
const int *  list,
const long long *  aux_list,
int  len,
int &  insertPoint 
)

Definition at line 961 of file Epetra_Util.cpp.

int Epetra_Util_ExtractHbData ( Epetra_CrsMatrix A,
Epetra_MultiVector LHS,
Epetra_MultiVector RHS,
int &  M,
int &  N,
int &  nz,
int *&  ptr,
int *&  ind,
double *&  val,
int &  Nrhs,
double *&  rhs,
int &  ldrhs,
double *&  lhs,
int &  ldlhs 
)

Harwell-Boeing data extraction routine.

This routine will extract data from an existing Epetra_Crs Matrix, and optionally from related rhs and lhs objects in a form that is compatible with software that requires the Harwell-Boeing data format. The matrix must be passed in, but the RHS and LHS arguments may be set to zero (either or both of them). For each of the LHS or RHS arguments, if non-trivial and contain more than one vector, the vectors must have strided access. If both LHS and RHS are non-trivial, they must have the same number of vectors. If the input objects are distributed, the returned matrices will contain the local part of the matrix and vectors only.

Parameters
A(In) Epetra_CrsMatrix.
LHS(In) Left hand side multivector. Set to zero if none not available or needed.
RHS(In) Right hand side multivector. Set to zero if none not available or needed.
M(Out) Local row dimension of matrix.
N(Out) Local column dimension of matrix.
nz(Out) Number of nonzero entries in matrix.
ptr(Out) Offsets into ind and val arrays pointing to start of each row's data.
ind(Out) Column indices of the matrix, in compressed form.
val(Out) Matrix values, in compressed form corresponding to the ind array.
Nrhs(Out) Number of right/left hand sides found (if any) in RHS and LHS.
rhs(Out) Fortran-style 2D array of RHS values.
ldrhs(Out) Stride between columns of rhs.
lhs(Out) Fortran-style 2D array of LHS values.
ldrhs(Out) Stride between columns of lhs.

Definition at line 973 of file Epetra_Util.cpp.