]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use the new namespace std_cxx0x in lac/ as well.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 13 Jan 2009 03:47:41 +0000 (03:47 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 13 Jan 2009 03:47:41 +0000 (03:47 +0000)
git-svn-id: https://svn.dealii.org/trunk@18196 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/lac/include/lac/filtered_matrix.h
deal.II/lac/include/lac/petsc_matrix_base.h
deal.II/lac/include/lac/petsc_solver.h
deal.II/lac/include/lac/trilinos_precondition.h
deal.II/lac/include/lac/trilinos_sparse_matrix.h
deal.II/lac/include/lac/trilinos_sparsity_pattern.h
deal.II/lac/source/trilinos_precondition.cc

index 969cb9cd0d70b0dcb34de1feef9d167c3adb8047..58fe000a26c4ed154a0c80eb103e8c32b9d1a6a0 100644 (file)
@@ -612,7 +612,7 @@ class FilteredMatrix : public Subscriptor
                                      * it using the SmartPointer
                                      * class.
                                      */
-    boost::shared_ptr<PointerMatrixBase<VECTOR> > matrix;
+    std_cxx0x::shared_ptr<PointerMatrixBase<VECTOR> > matrix;
 
                                     /**
                                      * Sorted list of pairs denoting
@@ -812,7 +812,7 @@ inline
 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;
index a6ed6d523a81af0465a0978d2fd444e4853ca739..0f2ab5953cab7c3f85d9adfa02f8a3a2aa4f8c4b 100644 (file)
@@ -22,7 +22,7 @@
 #ifdef DEAL_II_USE_PETSC
 
 #include <petscmat.h>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 #include <vector>
 #include <cmath>
 
@@ -150,13 +150,13 @@ namespace PETScWrappers
                                               * 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
index 03ec10e52fb69ed88d9155360b4f41889835fa77..0f51cedd215a6ff493fceb6b298c1715212c0e4b 100644 (file)
@@ -16,7 +16,7 @@
 #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
@@ -225,7 +225,7 @@ namespace PETScWrappers
                                         * the main solver routine if
                                         * necessary.
                                         */
-      boost::shared_ptr<SolverData> solver_data;
+      std_cxx0x::shared_ptr<SolverData> solver_data;
   };
 
 
index dde9daeff02931ae5f974f7df34133389226ac07..1d0aef06c28a5887391fd2f22580dc450c605552 100755 (executable)
@@ -19,7 +19,7 @@
 #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
@@ -1465,7 +1465,7 @@ namespace TrilinosWrappers
                                        * A copy of the deal.II matrix
                                        * into Trilinos format.
                                        */
-      boost::shared_ptr<SparseMatrix> Matrix;
+      std_cxx0x::shared_ptr<SparseMatrix> Matrix;
   };
 
 }
index de6f2bbd2fd99b0ac4e11b893ed8bcb3aa37fa42..ecd9b56e96918110c16b846c14892cf1bf5430cd 100755 (executable)
@@ -21,7 +21,7 @@
 #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>
@@ -163,13 +163,13 @@ namespace TrilinosWrappers
                                        * 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
index 7bab1edc20185c3f7a278eb02a77ddca4935a60d..e47ef726d46c6f2088f33f6a3e2512a4128c1115 100755 (executable)
@@ -18,7 +18,7 @@
 #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>
@@ -149,7 +149,7 @@ namespace TrilinosWrappers
                                        * 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
index ea3cc0db6d734ffdfecf8291807d49868e9efa14..73a94722ca07fdedfecd1c09af5144902a94702a 100755 (executable)
@@ -676,7 +676,7 @@ namespace TrilinosWrappers
     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();

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.