* it using the SmartPointer
* class.
*/
- boost::shared_ptr<PointerMatrixBase<VECTOR> > matrix;
+ std_cxx0x::shared_ptr<PointerMatrixBase<VECTOR> > matrix;
/**
* Sorted list of pairs denoting
void
FilteredMatrix<VECTOR>::initialize (const MATRIX &m, bool ecs)
{
- matrix = boost::shared_ptr<PointerMatrixBase<VECTOR> > (
+ matrix = std_cxx0x::shared_ptr<PointerMatrixBase<VECTOR> > (
new_pointer_matrix_base(m, VECTOR()));
expect_constrained_source = ecs;
#ifdef DEAL_II_USE_PETSC
#include <petscmat.h>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
#include <vector>
#include <cmath>
* accessor can access this data
* if necessary.
*/
- boost::shared_ptr<const std::vector<unsigned int> > colnum_cache;
+ std_cxx0x::shared_ptr<const std::vector<unsigned int> > colnum_cache;
/**
* Similar cache for the values
* of this row.
*/
- boost::shared_ptr<const std::vector<PetscScalar> > value_cache;
+ std_cxx0x::shared_ptr<const std::vector<PetscScalar> > value_cache;
/**
* Discard the old row caches
#include <base/config.h>
#include <lac/exceptions.h>
#include <lac/solver_control.h>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
#ifdef DEAL_II_USE_PETSC
* the main solver routine if
* necessary.
*/
- boost::shared_ptr<SolverData> solver_data;
+ std_cxx0x::shared_ptr<SolverData> solver_data;
};
#include <lac/vector.h>
#include <lac/sparse_matrix.h>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
#ifdef DEAL_II_USE_TRILINOS
* A copy of the deal.II matrix
* into Trilinos format.
*/
- boost::shared_ptr<SparseMatrix> Matrix;
+ std_cxx0x::shared_ptr<SparseMatrix> Matrix;
};
}
#include <lac/exceptions.h>
#include <lac/trilinos_vector_base.h>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
#include <vector>
#include <cmath>
#include <memory>
* than one accessor can access
* this data if necessary.
*/
- boost::shared_ptr<const std::vector<unsigned int> > colnum_cache;
+ std_cxx0x::shared_ptr<const std::vector<unsigned int> > colnum_cache;
/**
* Similar cache for the values
* of this row.
*/
- boost::shared_ptr<const std::vector<TrilinosScalar> > value_cache;
+ std_cxx0x::shared_ptr<const std::vector<TrilinosScalar> > value_cache;
/**
* Discard the old row caches
#include <base/subscriptor.h>
#include <lac/exceptions.h>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
#include <vector>
#include <cmath>
#include <memory>
* than one accessor can access
* this data if necessary.
*/
- boost::shared_ptr<const std::vector<unsigned int> > colnum_cache;
+ std_cxx0x::shared_ptr<const std::vector<unsigned int> > colnum_cache;
/**
* Discard the old row caches
map.reset (new Epetra_Map(n_rows, 0, communicator));
Matrix.reset();
- Matrix = boost::shared_ptr<SparseMatrix> (new SparseMatrix());
+ Matrix = std_cxx0x::shared_ptr<SparseMatrix> (new SparseMatrix());
Matrix->reinit (*map, deal_ii_sparse_matrix, drop_tolerance);
Matrix->compress();