From: Wolfgang Bangerth Date: Tue, 13 Jan 2009 03:47:41 +0000 (+0000) Subject: Use the new namespace std_cxx0x in lac/ as well. X-Git-Tag: v8.0.0~8134 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=808abd8ae318e9edcd06561a833f6a09bc30cd7c;p=dealii.git Use the new namespace std_cxx0x in lac/ as well. git-svn-id: https://svn.dealii.org/trunk@18196 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/lac/include/lac/filtered_matrix.h b/deal.II/lac/include/lac/filtered_matrix.h index 969cb9cd0d..58fe000a26 100644 --- a/deal.II/lac/include/lac/filtered_matrix.h +++ b/deal.II/lac/include/lac/filtered_matrix.h @@ -612,7 +612,7 @@ class FilteredMatrix : public Subscriptor * it using the SmartPointer * class. */ - boost::shared_ptr > matrix; + std_cxx0x::shared_ptr > matrix; /** * Sorted list of pairs denoting @@ -812,7 +812,7 @@ inline void FilteredMatrix::initialize (const MATRIX &m, bool ecs) { - matrix = boost::shared_ptr > ( + matrix = std_cxx0x::shared_ptr > ( new_pointer_matrix_base(m, VECTOR())); expect_constrained_source = ecs; diff --git a/deal.II/lac/include/lac/petsc_matrix_base.h b/deal.II/lac/include/lac/petsc_matrix_base.h index a6ed6d523a..0f2ab5953c 100644 --- a/deal.II/lac/include/lac/petsc_matrix_base.h +++ b/deal.II/lac/include/lac/petsc_matrix_base.h @@ -22,7 +22,7 @@ #ifdef DEAL_II_USE_PETSC #include -#include +#include #include #include @@ -150,13 +150,13 @@ namespace PETScWrappers * accessor can access this data * if necessary. */ - boost::shared_ptr > colnum_cache; + std_cxx0x::shared_ptr > colnum_cache; /** * Similar cache for the values * of this row. */ - boost::shared_ptr > value_cache; + std_cxx0x::shared_ptr > value_cache; /** * Discard the old row caches diff --git a/deal.II/lac/include/lac/petsc_solver.h b/deal.II/lac/include/lac/petsc_solver.h index 03ec10e52f..0f51cedd21 100644 --- a/deal.II/lac/include/lac/petsc_solver.h +++ b/deal.II/lac/include/lac/petsc_solver.h @@ -16,7 +16,7 @@ #include #include #include -#include +#include #ifdef DEAL_II_USE_PETSC @@ -225,7 +225,7 @@ namespace PETScWrappers * the main solver routine if * necessary. */ - boost::shared_ptr solver_data; + std_cxx0x::shared_ptr solver_data; }; diff --git a/deal.II/lac/include/lac/trilinos_precondition.h b/deal.II/lac/include/lac/trilinos_precondition.h index dde9daeff0..1d0aef06c2 100755 --- a/deal.II/lac/include/lac/trilinos_precondition.h +++ b/deal.II/lac/include/lac/trilinos_precondition.h @@ -19,7 +19,7 @@ #include #include -#include +#include #ifdef DEAL_II_USE_TRILINOS @@ -1465,7 +1465,7 @@ namespace TrilinosWrappers * A copy of the deal.II matrix * into Trilinos format. */ - boost::shared_ptr Matrix; + std_cxx0x::shared_ptr Matrix; }; } diff --git a/deal.II/lac/include/lac/trilinos_sparse_matrix.h b/deal.II/lac/include/lac/trilinos_sparse_matrix.h index de6f2bbd2f..ecd9b56e96 100755 --- a/deal.II/lac/include/lac/trilinos_sparse_matrix.h +++ b/deal.II/lac/include/lac/trilinos_sparse_matrix.h @@ -21,7 +21,7 @@ #include #include -#include +#include #include #include #include @@ -163,13 +163,13 @@ namespace TrilinosWrappers * than one accessor can access * this data if necessary. */ - boost::shared_ptr > colnum_cache; + std_cxx0x::shared_ptr > colnum_cache; /** * Similar cache for the values * of this row. */ - boost::shared_ptr > value_cache; + std_cxx0x::shared_ptr > value_cache; /** * Discard the old row caches diff --git a/deal.II/lac/include/lac/trilinos_sparsity_pattern.h b/deal.II/lac/include/lac/trilinos_sparsity_pattern.h index 7bab1edc20..e47ef726d4 100755 --- a/deal.II/lac/include/lac/trilinos_sparsity_pattern.h +++ b/deal.II/lac/include/lac/trilinos_sparsity_pattern.h @@ -18,7 +18,7 @@ #include #include -#include +#include #include #include #include @@ -149,7 +149,7 @@ namespace TrilinosWrappers * than one accessor can access * this data if necessary. */ - boost::shared_ptr > colnum_cache; + std_cxx0x::shared_ptr > colnum_cache; /** * Discard the old row caches diff --git a/deal.II/lac/source/trilinos_precondition.cc b/deal.II/lac/source/trilinos_precondition.cc index ea3cc0db6d..73a94722ca 100755 --- a/deal.II/lac/source/trilinos_precondition.cc +++ b/deal.II/lac/source/trilinos_precondition.cc @@ -676,7 +676,7 @@ namespace TrilinosWrappers map.reset (new Epetra_Map(n_rows, 0, communicator)); Matrix.reset(); - Matrix = boost::shared_ptr (new SparseMatrix()); + Matrix = std_cxx0x::shared_ptr (new SparseMatrix()); Matrix->reinit (*map, deal_ii_sparse_matrix, drop_tolerance); Matrix->compress();