43#ifndef IFPACK_LINEPARTITIONER_H
44#define IFPACK_LINEPARTITIONER_H
50#include "Teuchos_ParameterList.hpp"
137 mymode = List.get(
"partitioner: line mode",mymode);
164 void local_automatic_line_search(
int NumEqns,
int * blockIndices,
int last,
int next,
int LineID,
double tol,
int *itemp,
double * dtemp)
const;
#define IFPACK_CHK_ERR(ifpack_err)
adjacency_list< vecS, vecS, undirectedS, no_property, property< edge_weight_t, double > > Graph
Ifpack_Graph_Epetra_RowMatrix: a class to define Ifpack_Graph as a light-weight conversion of Epetra_...
Ifpack_Graph: a pure virtual class that defines graphs for IFPACK.
const Epetra_RowMatrix * Matrix_
Teuchos::RCP< const Ifpack_Graph > GraphWrapper_
int SetPartitionParameters(Teuchos::ParameterList &List)
Sets all the parameters for the partitioner.
int ComputePartitions()
Computes the partitions. Returns 0 if successful.
void local_automatic_line_search(int NumEqns, int *blockIndices, int last, int next, int LineID, double tol, int *itemp, double *dtemp) const
Ifpack_LinePartitioner(const Epetra_RowMatrix *Matrix)
int Compute_Blocks_AutoLine(int *blockIndices) const
Ifpack_LinePartitioner(const Ifpack_Graph *Graph)
Constructor.
virtual ~Ifpack_LinePartitioner()
Destructor.
const Ifpack_Graph * Graph_
Reference to the graph to be partitioned.