// reset the communication patter
source_stored_elements.clear();
- comm_pattern = NULL;
+ comm_pattern.reset();
}
// reset the communication patter
source_stored_elements.clear();
- comm_pattern = NULL;
+ comm_pattern.reset();
}
// reset the communication patter
source_stored_elements.clear();
- comm_pattern = NULL;
+ comm_pattern.reset();
}
*/
void reinit(const IndexSet &vector_space_vector_index_set,
const IndexSet &read_write_vector_index_set,
- const MPI_Comm &communicator) override;
+ const MPI_Comm &communicator);
/**
* Return the underlying MPI communicator.
*/
virtual void import(const ReadWriteVector<double> &V,
VectorOperation::values operation,
- std_cxx11::shared_ptr<const CommunicationPatternBase> communication_pattern = NULL);
+ std_cxx11::shared_ptr<const CommunicationPatternBase> communication_pattern =
+ std_cxx11::shared_ptr<const CommunicationPatternBase> ());
/**
* Multiply the entire vector by a fixed factor.
#include <deal.II/base/mpi.h>
#include <deal.II/base/numbers.h>
#include <deal.II/base/std_cxx11/shared_ptr.h>
+#include <deal.II/lac/vector.h>
DEAL_II_NAMESPACE_OPEN
*/
virtual void import(const ReadWriteVector<Number> &V,
VectorOperation::values operation,
- std_cxx11::shared_ptr<const CommunicationPatternBase> communication_pattern = NULL) = 0;
+ std_cxx11::shared_ptr<const CommunicationPatternBase> communication_pattern =
+ std_cxx11::shared_ptr<const CommunicationPatternBase> ()) = 0;
/**
* Return the scalar product of two vectors.
{
Vector::Vector()
:
- vector(new Epetra_FEVector(Epetra_Map(0,0,0,Utilities::Trilinos::comm_self()))),
- epetra_comm_pattern(NULL)
+ vector(new Epetra_FEVector(Epetra_Map(0,0,0,Utilities::Trilinos::comm_self())))
{}
Vector::Vector(const Vector &V)
:
- vector(new Epetra_FEVector(V.trilinos_vector())),
- epetra_comm_pattern(NULL)
+ vector(new Epetra_FEVector(V.trilinos_vector()))
{}
Vector::Vector(const IndexSet ¶llel_partitioner,
const MPI_Comm &communicator)
:
- vector(new Epetra_FEVector(parallel_partitioner.make_trilinos_map(communicator,false))),
- epetra_comm_pattern(NULL)
+ vector(new Epetra_FEVector(parallel_partitioner.make_trilinos_map(communicator,false)))
{}