]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Use namespace std_cxx0x where appropriate. The only place where we don't is where...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 13 Jan 2009 03:59:46 +0000 (03:59 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 13 Jan 2009 03:59:46 +0000 (03:59 +0000)
git-svn-id: https://svn.dealii.org/trunk@18197 0785d39b-7218-0410-832d-ea1e28bc413d

25 files changed:
deal.II/base/include/base/std_cxx0x/array.h [new file with mode: 0644]
deal.II/base/include/base/std_cxx0x/tuple.h
deal.II/deal.II/include/hp/fe_collection.h
deal.II/deal.II/include/hp/fe_values.h
deal.II/deal.II/include/hp/mapping_collection.h
deal.II/deal.II/include/hp/q_collection.h
deal.II/deal.II/include/multigrid/mg_level_object.h
deal.II/deal.II/include/multigrid/mg_transfer.h
deal.II/deal.II/include/multigrid/mg_transfer.templates.h
deal.II/deal.II/include/multigrid/mg_transfer_block.h
deal.II/deal.II/include/multigrid/mg_transfer_component.h
deal.II/deal.II/include/numerics/data_out.h
deal.II/deal.II/include/numerics/matrices.h
deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/fe/fe_tools.cc
deal.II/deal.II/source/grid/tria.cc
deal.II/deal.II/source/hp/dof_handler.cc
deal.II/deal.II/source/hp/fe_collection.cc
deal.II/deal.II/source/hp/fe_values.cc
deal.II/deal.II/source/hp/mapping_collection.cc
deal.II/deal.II/source/multigrid/mg_transfer_block.cc
deal.II/deal.II/source/multigrid/mg_transfer_component.cc
deal.II/deal.II/source/multigrid/mg_transfer_prebuilt.cc
deal.II/deal.II/source/numerics/data_out.cc
deal.II/deal.II/source/numerics/matrices.cc

diff --git a/deal.II/base/include/base/std_cxx0x/array.h b/deal.II/base/include/base/std_cxx0x/array.h
new file mode 100644 (file)
index 0000000..925aae6
--- /dev/null
@@ -0,0 +1,31 @@
+//---------------------------------------------------------------------------
+//    $Id: std_cxx0x_tuple.h 16094 2008-05-14 19:18:25Z bangerth $
+//    Version: $Name$
+//
+//    Copyright (C) 2009 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//---------------------------------------------------------------------------
+#ifndef __deal2__std_cxx0x_array_h
+#define __deal2__std_cxx0x_array_h
+
+
+#include <base/config.h>
+#include <boost/array.hpp>
+
+
+DEAL_II_NAMESPACE_OPEN
+
+namespace std_cxx0x
+{
+  using boost::array;
+}
+
+
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
index 20cd02976b4d7cd4f890d150a0c949dcd2022449..86ecd219ecc501f08f5b31e5e3b61285cf963f21 100644 (file)
@@ -23,6 +23,8 @@ DEAL_II_NAMESPACE_OPEN
 namespace std_cxx0x
 {
   using boost::tuple;
+  using boost::get;
+  
   namespace tuples
   {
     using namespace boost::tuples;
index d9f839b4332b5ef2c23309cff67079b08d71ac5f..46fc51f96010d89f0d115837db374510777380c3 100644 (file)
@@ -14,7 +14,7 @@
 #define __deal2__fe_collection_h
 
 #include <base/config.h>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 #include <fe/fe.h>
 
 DEAL_II_NAMESPACE_OPEN
@@ -215,7 +215,7 @@ namespace hp
                                         * Array of pointers to the finite
                                         * elements stored by this collection.
                                         */
-      std::vector<boost::shared_ptr<const FiniteElement<dim,spacedim> > > finite_elements;
+      std::vector<std_cxx0x::shared_ptr<const FiniteElement<dim,spacedim> > > finite_elements;
   };
 
 
index 4cfde4c097f4a8fd8801be5d2bb6721343bbfdfb..b09f2fc261ef693b7115c7e615116c7ede880758 100644 (file)
@@ -21,7 +21,7 @@
 #include <fe/fe_values.h>
 
 #include <map>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -163,7 +163,7 @@ namespace internal
                                           * as needed in
                                           * select_fe_values().
                                           */
-        Table<3,boost::shared_ptr<FEValues> > fe_values_table;
+        Table<3,std_cxx0x::shared_ptr<FEValues> > fe_values_table;
 
                                          /**
                                           * Set of indices pointing at
index 496c2eed3b6cb82dfb1979410714b33b497c6ce9..0b4769f6e81e3414e7c734b0a491a08c3b483c16 100644 (file)
@@ -19,7 +19,7 @@
 #include <fe/fe.h>
 
 #include <vector>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -128,7 +128,7 @@ namespace hp
                                         * pointers to the different Mapping
                                         * objects.
                                         */
-      std::vector<boost::shared_ptr<const Mapping<dim,spacedim> > > mappings;
+      std::vector<std_cxx0x::shared_ptr<const Mapping<dim,spacedim> > > mappings;
   };
 
 
index 55d97d51059b1103bc84fd64ccd4da2947f394ed..2b89c396e6c16203ad8db551d9289190265a0c58 100644 (file)
@@ -21,7 +21,7 @@
 #include <fe/fe.h>
 
 #include <vector>
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -146,7 +146,7 @@ namespace hp
                                         * pointers to the different quadrature
                                         * objects.
                                         */
-      std::vector<boost::shared_ptr<const Quadrature<dim> > > quadratures;
+      std::vector<std_cxx0x::shared_ptr<const Quadrature<dim> > > quadratures;
   };
 
 
@@ -205,7 +205,7 @@ namespace hp
   QCollection<dim>::QCollection (const Quadrature<dim> &quadrature)
   {
     quadratures
-      .push_back (boost::shared_ptr<const Quadrature<dim> >(new Quadrature<dim>(quadrature)));
+      .push_back (std_cxx0x::shared_ptr<const Quadrature<dim> >(new Quadrature<dim>(quadrature)));
   }
 
   
@@ -248,7 +248,7 @@ namespace hp
   QCollection<dim>::push_back (const Quadrature<dim> &new_quadrature)
   {
     quadratures
-      .push_back (boost::shared_ptr<const Quadrature<dim> >(new Quadrature<dim>(new_quadrature)));
+      .push_back (std_cxx0x::shared_ptr<const Quadrature<dim> >(new Quadrature<dim>(new_quadrature)));
   }
   
 } // namespace hp
index 6cf3501f722c798203f9ce2bcdc9ea56bf799418..2110d061b874578816ffff75299195c382c8c29b 100644 (file)
@@ -16,7 +16,7 @@
 #include <base/subscriptor.h>
 #include <vector>
 
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -113,7 +113,7 @@ class MGLevelObject : public Subscriptor
                                     /**
                                      * Array of the objects to be held.
                                      */
-    std::vector<boost::shared_ptr<Object> > objects;
+    std::vector<std_cxx0x::shared_ptr<Object> > objects;
 };
 
 /*@}*/
@@ -165,7 +165,7 @@ MGLevelObject<Object>::resize (const unsigned int new_minlevel,
 
   minlevel = new_minlevel;
   for (unsigned int i=0; i<new_maxlevel-new_minlevel+1; ++i)
-    objects.push_back(boost::shared_ptr<Object> (new Object)); 
+    objects.push_back(std_cxx0x::shared_ptr<Object> (new Object)); 
 }
 
 
@@ -173,7 +173,7 @@ template<class Object>
 MGLevelObject<Object> &
 MGLevelObject<Object>::operator = (const double d)
 {
-  typename std::vector<boost::shared_ptr<Object> >::iterator v;
+  typename std::vector<std_cxx0x::shared_ptr<Object> >::iterator v;
   for (v = objects.begin(); v != objects.end(); ++v)
     **v=d;
   return *this;
@@ -184,7 +184,7 @@ template<class Object>
 void
 MGLevelObject<Object>::clear ()
 {
-  typename std::vector<boost::shared_ptr<Object> >::iterator v;
+  typename std::vector<std_cxx0x::shared_ptr<Object> >::iterator v;
   for (v = objects.begin(); v != objects.end(); ++v)
     (*v)->clear();
 }
@@ -211,7 +211,7 @@ unsigned int
 MGLevelObject<Object>::memory_consumption () const
 {
   unsigned int result = sizeof(*this);
-  typedef typename std::vector<boost::shared_ptr<Object> >::const_iterator Iter;
+  typedef typename std::vector<std_cxx0x::shared_ptr<Object> >::const_iterator Iter;
   const Iter end = objects.end();
   for (Iter o=objects.begin(); o!=end; ++o)
     result += (*o)->memory_consumption();
index a7a21639939eff7d3093b75f2e1aa6cc612835b7..8108c423a689bc0a891e80339e2e272efbcc4753 100644 (file)
@@ -32,7 +32,7 @@
 
 #include <dofs/dof_handler.h>
 
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 
 DEAL_II_NAMESPACE_OPEN
@@ -156,7 +156,7 @@ class MGTransferPrebuilt : public MGTransferBase<VECTOR>
                                      * Sparsity patterns for transfer
                                      * matrices.
                                      */
-    std::vector<boost::shared_ptr<SparsityPattern> >   prolongation_sparsities;
+    std::vector<std_cxx0x::shared_ptr<SparsityPattern> >   prolongation_sparsities;
 
                                     /**
                                      * The actual prolongation matrix.
@@ -166,7 +166,7 @@ class MGTransferPrebuilt : public MGTransferBase<VECTOR>
                                      * while row indices belong to the
                                      * child cell, i.e. the fine level.
                                      */
-    std::vector<boost::shared_ptr<SparseMatrix<double> > > prolongation_matrices;    
+    std::vector<std_cxx0x::shared_ptr<SparseMatrix<double> > > prolongation_matrices;    
     
                                     /**
                                      * Mapping for the
index defcfc4b3d49c825df3322f3f065b3e1bb17887b..0660168b793b72b12010acd514298e056c5be260 100644 (file)
@@ -95,8 +95,8 @@ MGTransferPrebuilt<VECTOR>::memory_consumption () const
   unsigned int result = sizeof(*this);
   result += sizeof(unsigned int) * sizes.size();
 #ifdef DEAL_PREFER_MATRIX_EZ
-  std::vector<boost::shared_ptr<SparseMatrixEZ<double> > >::const_iterator m;
-  const std::vector<boost::shared_ptr<SparseMatrixEZ<double> > >::const_iterator end = prolongation_matrices.end();
+  std::vector<std_cxx0x::shared_ptr<SparseMatrixEZ<double> > >::const_iterator m;
+  const std::vector<std_cxx0x::shared_ptr<SparseMatrixEZ<double> > >::const_iterator end = prolongation_matrices.end();
   for (m = prolongation_matrices.begin(); m != end ; ++m)
     result += *m->memory_consumption();
 #else
index 11f6f991170389ec0b4674a91e497f2fbe33abc3..09f959cc73cdc9ee9fe2e3280581a47411fedf08 100644 (file)
@@ -33,7 +33,7 @@
 
 #include <dofs/dof_handler.h>
 
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 
 DEAL_II_NAMESPACE_OPEN
@@ -133,7 +133,7 @@ class MGTransferBlockBase
     DeclException0(ExcMatricesNotBuilt);
     
   private:
-    std::vector<boost::shared_ptr<BlockSparsityPattern> >   prolongation_sparsities;
+    std::vector<std_cxx0x::shared_ptr<BlockSparsityPattern> >   prolongation_sparsities;
     
   protected:
     
@@ -145,7 +145,7 @@ class MGTransferBlockBase
                                      * while row indices belong to the
                                      * child cell, i.e. the fine level.
                                      */
-    std::vector<boost::shared_ptr<BlockSparseMatrix<double> > > prolongation_matrices;
+    std::vector<std_cxx0x::shared_ptr<BlockSparseMatrix<double> > > prolongation_matrices;
     
                                     /**
                                      * Mapping for the
index 6384012c2107d5a31093d32819670dc78b379bd4..4376ad64e896162d425d9f0d0e53c9d2905c958a 100644 (file)
@@ -32,7 +32,7 @@
 
 #include <dofs/dof_handler.h>
 
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 
 DEAL_II_NAMESPACE_OPEN
@@ -149,7 +149,7 @@ class MGTransferComponentBase
     DeclException0(ExcMatricesNotBuilt);
     
   private:
-    std::vector<boost::shared_ptr<BlockSparsityPattern> >   prolongation_sparsities;
+    std::vector<std_cxx0x::shared_ptr<BlockSparsityPattern> >   prolongation_sparsities;
     
   protected:
     
@@ -161,7 +161,7 @@ class MGTransferComponentBase
                                      * while row indices belong to the
                                      * child cell, i.e. the fine level.
                                      */
-    std::vector<boost::shared_ptr<BlockSparseMatrix<double> > > prolongation_matrices;
+    std::vector<std_cxx0x::shared_ptr<BlockSparseMatrix<double> > > prolongation_matrices;
     
                                     /**
                                      * Unused now, but intended to
index ca48ba1d90b74fe03e57d5a8433dfe324ad47cf3..c66039677dee32ad4714f1c93b6b9bca1e094179 100644 (file)
@@ -24,7 +24,7 @@
 #include <numerics/data_postprocessor.h>
 #include <numerics/data_component_interpretation.h>
 
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -1002,13 +1002,13 @@ class DataOut_DoFData : public DataOutInterface<patch_dim,patch_space_dim>
                                      * List of data elements with vectors of
                                      * values for each degree of freedom.
                                      */
-    std::vector<boost::shared_ptr<DataEntryBase> >  dof_data;
+    std::vector<std_cxx0x::shared_ptr<DataEntryBase> >  dof_data;
 
                                     /**
                                      * List of data elements with vectors of
                                      * values for each cell.
                                      */
-    std::vector<boost::shared_ptr<DataEntryBase> >  cell_data;
+    std::vector<std_cxx0x::shared_ptr<DataEntryBase> >  cell_data;
 
                                     /**
                                      * This is a list of patches that is
@@ -1044,7 +1044,7 @@ class DataOut_DoFData : public DataOutInterface<patch_dim,patch_space_dim>
                                      * extensive documentation.
                                      */
     virtual
-    std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+    std::vector<std_cxx0x::tuple<unsigned int, unsigned int, std::string> >
     get_vector_data_ranges () const;
     
                                     /**
index 1fd1f6b784af89012a3d71ea23069c738cea18a2..9a1e465915a779931739056b75f4369f559e3ffd 100644 (file)
@@ -795,7 +795,7 @@ class MatrixCreator
                                      */
     template <int dim, int spacedim>
     static
-    void create_boundary_mass_matrix_1 (boost::tuple<const Mapping<dim,spacedim> &,
+    void create_boundary_mass_matrix_1 (std_cxx0x::tuple<const Mapping<dim,spacedim> &,
                                        const DoFHandler<dim,spacedim> &,
                                        const Quadrature<dim-1> & > commons,
                                        SparseMatrix<double>     &matrix,
@@ -812,7 +812,7 @@ class MatrixCreator
                                      */
     template <int dim, int spacedim>
     static
-    void create_boundary_mass_matrix_1 (boost::tuple<const hp::MappingCollection<dim,spacedim> &,
+    void create_boundary_mass_matrix_1 (std_cxx0x::tuple<const hp::MappingCollection<dim,spacedim> &,
                                        const hp::DoFHandler<dim,spacedim>&,
                                        const hp::QCollection<dim-1> & > commons,
                                        SparseMatrix<double>     &matrix,
index 1c38e132480e814e96963fdd1ce00b67219fb50c..4237e0c605b6781e3447f7f6dc0a6efb1a639f31 100644 (file)
@@ -1332,11 +1332,11 @@ namespace internal
       ensure_existence_of_master_dof_mask (const FiniteElement<dim,spacedim> &fe1,
                                           const FiniteElement<dim,spacedim> &fe2,
                                           const FullMatrix<double> &face_interpolation_matrix,
-                                          boost::shared_ptr<std::vector<bool> > &master_dof_mask)
+                                          std_cxx0x::shared_ptr<std::vector<bool> > &master_dof_mask)
       {
        if (master_dof_mask == 0)
          {
-           master_dof_mask = boost::shared_ptr<std::vector<bool> >
+           master_dof_mask = std_cxx0x::shared_ptr<std::vector<bool> >
                              (new std::vector<bool> (fe1.dofs_per_face));
            select_master_dofs_for_face_restriction (fe1,
                                                     fe2,
@@ -1359,11 +1359,11 @@ namespace internal
       void
       ensure_existence_of_face_matrix (const FiniteElement<dim,spacedim> &fe1,
                                        const FiniteElement<dim,spacedim> &fe2,
-                                       boost::shared_ptr<FullMatrix<double> > &matrix)
+                                       std_cxx0x::shared_ptr<FullMatrix<double> > &matrix)
       {
         if (matrix == 0)
           {
-            matrix = boost::shared_ptr<FullMatrix<double> >
+            matrix = std_cxx0x::shared_ptr<FullMatrix<double> >
                      (new FullMatrix<double> (fe2.dofs_per_face,
                                               fe1.dofs_per_face));
             fe1.get_face_interpolation_matrix (fe2,
@@ -1382,11 +1382,11 @@ namespace internal
       ensure_existence_of_subface_matrix (const FiniteElement<dim,spacedim> &fe1,
                                           const FiniteElement<dim,spacedim> &fe2,
                                           const unsigned int        subface,
-                                          boost::shared_ptr<FullMatrix<double> > &matrix)
+                                          std_cxx0x::shared_ptr<FullMatrix<double> > &matrix)
       {
         if (matrix == 0)
           {
-            matrix = boost::shared_ptr<FullMatrix<double> >
+            matrix = std_cxx0x::shared_ptr<FullMatrix<double> >
                      (new FullMatrix<double> (fe2.dofs_per_face,
                                               fe1.dofs_per_face));
             fe1.get_subface_interpolation_matrix (fe2,
@@ -1410,7 +1410,7 @@ namespace internal
       void
       ensure_existence_of_split_face_matrix (const FullMatrix<double> &face_interpolation_matrix,
                                             const std::vector<bool> &master_dof_mask,
-                                            boost::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > > &split_matrix)
+                                            std_cxx0x::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > > &split_matrix)
       {
        Assert (master_dof_mask.size() == face_interpolation_matrix.m(),
                ExcInternalError());
@@ -1421,7 +1421,7 @@ namespace internal
         if (split_matrix == 0)
           {
             split_matrix
-             = boost::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > >
+             = std_cxx0x::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > >
              (new std::pair<FullMatrix<double>,FullMatrix<double> >());
 
            const unsigned int n_master_dofs = face_interpolation_matrix.n();
@@ -2195,10 +2195,10 @@ namespace internal
                                        // only once, namely the first
                                        // time they are needed, and
                                        // then just reuse them
-      Table<2,boost::shared_ptr<FullMatrix<double> > >
+      Table<2,std_cxx0x::shared_ptr<FullMatrix<double> > >
         face_interpolation_matrices (n_finite_elements (dof_handler),
                                      n_finite_elements (dof_handler));
-      Table<3,boost::shared_ptr<FullMatrix<double> > >
+      Table<3,std_cxx0x::shared_ptr<FullMatrix<double> > >
         subface_interpolation_matrices (n_finite_elements (dof_handler),
                                         n_finite_elements (dof_handler),
                                         GeometryInfo<dim>::max_children_per_face);
@@ -2212,7 +2212,7 @@ namespace internal
                                       // are derived from the face
                                       // interpolation matrix as
                                       // described in the @ref hp_paper "hp paper"
-      Table<2,boost::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > > >
+      Table<2,std_cxx0x::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > > >
         split_face_interpolation_matrices (n_finite_elements (dof_handler),
                                           n_finite_elements (dof_handler));
 
@@ -2221,7 +2221,7 @@ namespace internal
                                       // which of the degrees of freedom on
                                       // the coarse side of a refined face
                                       // will act as master dofs.
-      Table<2,boost::shared_ptr<std::vector<bool> > >
+      Table<2,std_cxx0x::shared_ptr<std::vector<bool> > >
        master_dof_masks (n_finite_elements (dof_handler),
                          n_finite_elements (dof_handler));
       
index 592b4bc0179ee91fa766f5a8399e3c4c10faffd6..eb5b92a437e7bd799546746014d457d72bbf8d69 100644 (file)
@@ -45,7 +45,7 @@
 #include <dofs/dof_tools.h>
 #include <hp/dof_handler.h>
 
-#include <boost/shared_ptr.hpp>
+#include <base/std_cxx0x/shared_ptr.h>
 
 
 DEAL_II_NAMESPACE_OPEN
@@ -60,7 +60,7 @@ namespace
                                    // apparent memory leaks to
                                    // programs like valgrind
   typedef
-  boost::shared_ptr<const FETools::FEFactoryBase<deal_II_dimension> >
+  std_cxx0x::shared_ptr<const FETools::FEFactoryBase<deal_II_dimension> >
   FEFactoryPointer;
   
                                    // a function that returns the
@@ -142,7 +142,7 @@ namespace
                                    // issues here
   static
   std::map<std::string,
-          boost::shared_ptr<const FETools::FEFactoryBase<deal_II_dimension> > >
+          std_cxx0x::shared_ptr<const FETools::FEFactoryBase<deal_II_dimension> > >
   fe_name_map
   = get_default_fe_names ();
 }
@@ -1071,7 +1071,7 @@ FETools::interpolate (const DH1<dim, spacedim> &dof1,
                                    // that memory is released again
   std::map<const FiniteElement<dim,spacedim> *,
            std::map<const FiniteElement<dim,spacedim> *,
-                    boost::shared_ptr<FullMatrix<double> > > >
+                    std_cxx0x::shared_ptr<FullMatrix<double> > > >
     interpolation_matrices;
   
   typename DH1<dim,spacedim>::active_cell_iterator cell1 = dof1.begin_active(),
@@ -1119,7 +1119,7 @@ FETools::interpolate (const DH1<dim, spacedim> &dof1,
                                        // there
       if (interpolation_matrices[&cell1->get_fe()][&cell2->get_fe()] == 0)
         {
-          boost::shared_ptr<FullMatrix<double> >
+          std_cxx0x::shared_ptr<FullMatrix<double> >
             interpolation_matrix (new FullMatrix<double> (dofs_per_cell2,
                                                           dofs_per_cell1));
           interpolation_matrices[&cell1->get_fe()][&cell2->get_fe()]
@@ -1236,7 +1236,7 @@ FETools::back_interpolate(const DH<dim>            &dof1,
                                    // dof1 to the back_interpolation
                                    // matrices
   std::map<const FiniteElement<dim> *,
-           boost::shared_ptr<FullMatrix<double> > > interpolation_matrices;
+           std_cxx0x::shared_ptr<FullMatrix<double> > > interpolation_matrices;
   
   for (; cell!=endc; ++cell) 
     {
@@ -1267,7 +1267,7 @@ FETools::back_interpolate(const DH<dim>            &dof1,
       if (interpolation_matrices[&cell->get_fe()] != 0)
         {
           interpolation_matrices[&cell->get_fe()] =
-            boost::shared_ptr<FullMatrix<double> >
+            std_cxx0x::shared_ptr<FullMatrix<double> >
             (new FullMatrix<double>(dofs_per_cell1, dofs_per_cell1));
           get_back_interpolation_matrix(dof1.get_fe(), fe2,
                                         *interpolation_matrices[&cell->get_fe()]);
index 8c1f76a9c12c23f9e726382a7114e894d3c4ecf8..8ab7b2204a194f397a0d49b7006b77e7f4b827ba 100644 (file)
@@ -31,7 +31,7 @@
 #include <iostream>
 #include <functional>
 
-#include <boost/array.hpp>
+#include <base/std_cxx0x/array.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -1951,7 +1951,7 @@ namespace internal
                                             // this file
            std::map<internal::Triangulation::TriaObject<2>,
                     std::pair<typename Triangulation<dim,spacedim>::quad_iterator,
-                              boost::array<bool,GeometryInfo<dim>::lines_per_face> >,
+                              std_cxx0x::array<bool,GeometryInfo<dim>::lines_per_face> >,
                     QuadComparator>
              needed_quads;
            for (unsigned int cell=0; cell<cells.size(); ++cell) 
@@ -1982,7 +1982,7 @@ namespace internal
                std::pair<int,int> line_list[GeometryInfo<dim>::lines_per_cell],
                  inverse_line_list[GeometryInfo<dim>::lines_per_cell];
                unsigned int face_line_list[GeometryInfo<dim>::lines_per_face];
-               boost::array<bool,GeometryInfo<dim>::lines_per_face> orientation;
+               std_cxx0x::array<bool,GeometryInfo<dim>::lines_per_face> orientation;
       
                for (unsigned int line=0; line<GeometryInfo<dim>::lines_per_cell; ++line)
                  {
@@ -2103,7 +2103,7 @@ namespace internal
                quad = triangulation.begin_raw_quad();
              typename std::map<internal::Triangulation::TriaObject<2>,
                std::pair<typename Triangulation<dim,spacedim>::quad_iterator,
-               boost::array<bool,GeometryInfo<dim>::lines_per_face> >,
+               std_cxx0x::array<bool,GeometryInfo<dim>::lines_per_face> >,
                QuadComparator>
                ::iterator q;
              for (q = needed_quads.begin(); quad!=triangulation.end_quad(); ++quad, ++q)
index 1f673e7f000cd3098674e04464d5580494377d42..3bfe37692628846aef06a258caec03963f80bf3c 100644 (file)
@@ -58,7 +58,7 @@ namespace internal
     void
     ensure_existence_of_dof_identities (const FiniteElement<dim> &fe1,
                                        const FiniteElement<dim> &fe2,
-                                       boost::shared_ptr<DoFIdentities> &identities)
+                                       std_cxx0x::shared_ptr<DoFIdentities> &identities)
     {
                                       // see if we need to fill this
                                       // entry, or whether it already
@@ -70,7 +70,7 @@ namespace internal
              case 0:
              {
                identities =
-                 boost::shared_ptr<DoFIdentities>
+                 std_cxx0x::shared_ptr<DoFIdentities>
                  (new DoFIdentities(fe1.hp_vertex_dof_identities(fe2)));
                break;
              }
@@ -78,7 +78,7 @@ namespace internal
              case 1:
              {
                identities =
-                 boost::shared_ptr<DoFIdentities>
+                 std_cxx0x::shared_ptr<DoFIdentities>
                  (new DoFIdentities(fe1.hp_line_dof_identities(fe2)));
                break;
              }
@@ -86,7 +86,7 @@ namespace internal
              case 2:
              {
                identities =
-                 boost::shared_ptr<DoFIdentities>
+                 std_cxx0x::shared_ptr<DoFIdentities>
                  (new DoFIdentities(fe1.hp_quad_dof_identities(fe2)));
                break;
              }
@@ -2952,7 +2952,7 @@ namespace hp
                                      // vertices at all, I can't think
                                      // of a finite element that would
                                      // make that necessary...
-    Table<2,boost::shared_ptr<internal::hp::DoFIdentities> >
+    Table<2,std_cxx0x::shared_ptr<internal::hp::DoFIdentities> >
       vertex_dof_identities (get_fe().size(),
                             get_fe().size());
 
@@ -3098,7 +3098,7 @@ namespace hp
                                     // and then only deal with those that are
                                     // not identical of which we can handle
                                     // at most 2
-    Table<2,boost::shared_ptr<internal::hp::DoFIdentities> >
+    Table<2,std_cxx0x::shared_ptr<internal::hp::DoFIdentities> >
       line_dof_identities (finite_elements->size(),
                           finite_elements->size());
        
@@ -3333,7 +3333,7 @@ namespace hp
                                      // for quads only in 4d and
                                      // higher, so this isn't a
                                      // particularly frequent case
-    Table<2,boost::shared_ptr<internal::hp::DoFIdentities> >
+    Table<2,std_cxx0x::shared_ptr<internal::hp::DoFIdentities> >
       quad_dof_identities (finite_elements->size(),
                           finite_elements->size());
        
index 8593aa19740f4769a223f0e5263e4589d6ca953e..a0ecc883609ba5eda25f2ffadc289a468819d1ba 100644 (file)
@@ -67,7 +67,7 @@ namespace hp
                           "same number of vector components!"));
   
     finite_elements
-      .push_back (boost::shared_ptr<const FiniteElement<dim,spacedim> >(new_fe.clone()));
+      .push_back (std_cxx0x::shared_ptr<const FiniteElement<dim,spacedim> >(new_fe.clone()));
   }
 
 
index 13a2d535e32642ddbd64d4ecbb5ffe98e33708d2..5715f34a3632226b77b8861c727f807ae0217f80 100644 (file)
@@ -93,7 +93,7 @@ namespace internal
       if (fe_values_table(present_fe_values_index) == 0)
         fe_values_table(present_fe_values_index)
           =
-          boost::shared_ptr<FEValues>
+          std_cxx0x::shared_ptr<FEValues>
           (new FEValues ((*mapping_collection)[mapping_index],
                          (*fe_collection)[fe_index],
                          q_collection[q_index],
index 29fc3080bcc146ed9a007f6acf3d8f92f6dfbd98..010b7adef5d2f06d0e4ed263ab6bbe8bf6f684fa 100644 (file)
@@ -31,7 +31,7 @@ namespace hp
   MappingCollection (const Mapping<dim,spacedim> &mapping)
   {
     mappings
-      .push_back (boost::shared_ptr<const Mapping<dim,spacedim> >(mapping.clone()));
+      .push_back (std_cxx0x::shared_ptr<const Mapping<dim,spacedim> >(mapping.clone()));
   }
 
 
@@ -72,7 +72,7 @@ namespace hp
   MappingCollection<dim,spacedim>::push_back (const Mapping<dim,spacedim> &new_mapping)
   {
     mappings
-      .push_back (boost::shared_ptr<const Mapping<dim,spacedim> >(new_mapping.clone()));
+      .push_back (std_cxx0x::shared_ptr<const Mapping<dim,spacedim> >(new_mapping.clone()));
   }
 
 //---------------------------------------------------------------------------
index b7f6423fe47a84da64635dc51584571a996c52ac..b1eeab278ebeda682b73ee2a96835b63bec3cd62 100644 (file)
@@ -116,9 +116,9 @@ void MGTransferBlockBase::build_matrices (
   for (unsigned int i=0; i<n_levels-1; ++i)
     {
       prolongation_sparsities
-       .push_back (boost::shared_ptr<BlockSparsityPattern> (new BlockSparsityPattern));
+       .push_back (std_cxx0x::shared_ptr<BlockSparsityPattern> (new BlockSparsityPattern));
       prolongation_matrices
-       .push_back (boost::shared_ptr<BlockSparseMatrix<double> > (new BlockSparseMatrix<double>));
+       .push_back (std_cxx0x::shared_ptr<BlockSparseMatrix<double> > (new BlockSparseMatrix<double>));
     }
 
                                   // two fields which will store the
index f068b66e8af2157a4ec7145161b7fd4e178b0bfc..96eb06b3f00cf42721b34be674d6178e40b8d699 100644 (file)
@@ -152,9 +152,9 @@ void MGTransferComponentBase::build_matrices (
   for (unsigned int i=0; i<n_levels-1; ++i)
     {
       prolongation_sparsities
-       .push_back (boost::shared_ptr<BlockSparsityPattern> (new BlockSparsityPattern));
+       .push_back (std_cxx0x::shared_ptr<BlockSparsityPattern> (new BlockSparsityPattern));
       prolongation_matrices
-       .push_back (boost::shared_ptr<BlockSparseMatrix<double> > (new BlockSparseMatrix<double>));
+       .push_back (std_cxx0x::shared_ptr<BlockSparseMatrix<double> > (new BlockSparseMatrix<double>));
     }
 
                                   // two fields which will store the
index b2fd0fd45fc9af0afcb668b44b999a39f5fd91ea..5500767d1eab51a0f6060386a90332b0f7841933 100644 (file)
@@ -58,9 +58,9 @@ void MGTransferPrebuilt<number>::build_matrices (
   for (unsigned int i=0; i<n_levels-1; ++i)
     {
       prolongation_sparsities
-       .push_back (boost::shared_ptr<SparsityPattern> (new SparsityPattern));
+       .push_back (std_cxx0x::shared_ptr<SparsityPattern> (new SparsityPattern));
       prolongation_matrices
-       .push_back (boost::shared_ptr<SparseMatrix<double> > (new SparseMatrix<double>));
+       .push_back (std_cxx0x::shared_ptr<SparseMatrix<double> > (new SparseMatrix<double>));
     }
   
                                   // two fields which will store the
index 9e4dcf74d91df2fa35ca954b61a2221428414975..438c9ab8d60dd2ac36b381b2fa932a9a7cf0b98c 100644 (file)
@@ -385,9 +385,9 @@ add_data_vector (const VECTOR                             &vec,
   DataEntryBase * new_entry = new DataEntry<VECTOR>(&vec, names,
                                                    data_component_interpretation);
   if (actual_type == type_dof_data)
-    dof_data.push_back (boost::shared_ptr<DataEntryBase>(new_entry));
+    dof_data.push_back (std_cxx0x::shared_ptr<DataEntryBase>(new_entry));
   else
-    cell_data.push_back (boost::shared_ptr<DataEntryBase>(new_entry));
+    cell_data.push_back (std_cxx0x::shared_ptr<DataEntryBase>(new_entry));
 }
 
 
@@ -416,7 +416,7 @@ add_data_vector (const VECTOR                           &vec,
                                dofs->get_tria().n_active_cells()));
 
   DataEntryBase * new_entry = new DataEntry<VECTOR>(&vec, &data_postprocessor);
-  dof_data.push_back (boost::shared_ptr<DataEntryBase>(new_entry));
+  dof_data.push_back (std_cxx0x::shared_ptr<DataEntryBase>(new_entry));
 }
 
 
@@ -481,7 +481,7 @@ get_dataset_names () const
                                   // collect the names of dof
                                   // and cell data
   typedef
-    typename std::vector<boost::shared_ptr<DataEntryBase> >::const_iterator
+    typename std::vector<std_cxx0x::shared_ptr<DataEntryBase> >::const_iterator
     data_iterator;
   
   for (data_iterator  d=dof_data.begin();
@@ -501,16 +501,16 @@ get_dataset_names () const
 
 template <class DH,
          int patch_dim, int patch_space_dim>
-std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+std::vector<std_cxx0x::tuple<unsigned int, unsigned int, std::string> >
 DataOut_DoFData<DH,patch_dim,patch_space_dim>::get_vector_data_ranges () const
 {
-  std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+  std::vector<std_cxx0x::tuple<unsigned int, unsigned int, std::string> >
     ranges;
   
                                   // collect the ranges of dof
                                   // and cell data
   typedef
-    typename std::vector<boost::shared_ptr<DataEntryBase> >::const_iterator
+    typename std::vector<std_cxx0x::shared_ptr<DataEntryBase> >::const_iterator
     data_iterator;
 
   unsigned int output_component = 0;
@@ -556,7 +556,7 @@ DataOut_DoFData<DH,patch_dim,patch_space_dim>::get_vector_data_ranges () const
 
                                           // finally add a corresponding
                                           // range
-         boost::tuple<unsigned int, unsigned int, std::string>
+         std_cxx0x::tuple<unsigned int, unsigned int, std::string>
            range (output_component,
                   output_component+patch_space_dim-1,
                   name);
index 3c650dbe0935a62c395a4e38a2f1891dc534367e..5512ee906191bd79dda39a877bd5a29fbd8c3dc0 100644 (file)
@@ -1080,7 +1080,7 @@ MatrixCreator::create_boundary_mass_matrix (const Mapping<dim, spacedim>  &mappi
                                   // the matrix
   Threads::ThreadMutex mutex;
 
-  typedef boost::tuple<const Mapping<dim,spacedim>&,
+  typedef std_cxx0x::tuple<const Mapping<dim,spacedim>&,
     const DoFHandler<dim,spacedim>&,
     const Quadrature<dim-1>&> Commons;
   
@@ -1111,7 +1111,7 @@ MatrixCreator::create_boundary_mass_matrix (const Mapping<dim, spacedim>  &mappi
 template <>
 void
 MatrixCreator::
-create_boundary_mass_matrix_1<2,3> (boost::tuple<const Mapping<2,3> &,
+create_boundary_mass_matrix_1<2,3> (std_cxx0x::tuple<const Mapping<2,3> &,
                                    const DoFHandler<2,3> &,
                                    const Quadrature<1> & > ,
                                    SparseMatrix<double>  &,
@@ -1132,7 +1132,7 @@ create_boundary_mass_matrix_1<2,3> (boost::tuple<const Mapping<2,3> &,
 template <int dim, int spacedim>
 void
 MatrixCreator::
-create_boundary_mass_matrix_1 (boost::tuple<const Mapping<dim, spacedim> &,
+create_boundary_mass_matrix_1 (std_cxx0x::tuple<const Mapping<dim, spacedim> &,
                               const DoFHandler<dim,spacedim> &,
                               const Quadrature<dim-1> & >  commons,
                               SparseMatrix<double>      &matrix,
@@ -1147,9 +1147,9 @@ create_boundary_mass_matrix_1 (boost::tuple<const Mapping<dim, spacedim> &,
                                   // All assertions for this function
                                   // are in the calling function
                                   // before creating threads.
-  const Mapping<dim,spacedim>& mapping = boost::get<0>(commons);
-  const DoFHandler<dim,spacedim>& dof = boost::get<1>(commons);
-  const Quadrature<dim-1>& q = boost::get<2>(commons);
+  const Mapping<dim,spacedim>& mapping = std_cxx0x::get<0>(commons);
+  const DoFHandler<dim,spacedim>& dof = std_cxx0x::get<1>(commons);
+  const Quadrature<dim-1>& q = std_cxx0x::get<2>(commons);
   
   const FiniteElement<dim,spacedim> &fe = dof.get_fe();
   const unsigned int n_components  = fe.n_components();
@@ -1482,7 +1482,7 @@ MatrixCreator::create_boundary_mass_matrix (const hp::MappingCollection<dim,spac
     = Threads::split_range<active_cell_iterator> (dof.begin_active(),
                                                  dof.end(), n_threads);
 
-  typedef boost::tuple<const hp::MappingCollection<dim>&,
+  typedef std_cxx0x::tuple<const hp::MappingCollection<dim>&,
     const hp::DoFHandler<dim>&,
     const hp::QCollection<dim-1>&> Commons;
   
@@ -1516,7 +1516,7 @@ MatrixCreator::create_boundary_mass_matrix (const hp::MappingCollection<dim,spac
 template <int dim, int spacedim>
 void
 MatrixCreator::
-create_boundary_mass_matrix_1 (boost::tuple<const hp::MappingCollection<dim,spacedim> &,
+create_boundary_mass_matrix_1 (std_cxx0x::tuple<const hp::MappingCollection<dim,spacedim> &,
                               const hp::DoFHandler<dim,spacedim> &,
                               const hp::QCollection<dim-1> &> commons,
                               SparseMatrix<double>      &matrix,
@@ -1528,9 +1528,9 @@ create_boundary_mass_matrix_1 (boost::tuple<const hp::MappingCollection<dim,spac
                               const IteratorRange<hp::DoFHandler<dim,spacedim> >   range,
                               Threads::ThreadMutex      &mutex)
 {
-  const hp::MappingCollection<dim>& mapping = boost::get<0>(commons);
-  const hp::DoFHandler<dim>& dof = boost::get<1>(commons);
-  const hp::QCollection<dim-1>& q = boost::get<2>(commons);
+  const hp::MappingCollection<dim>& mapping = std_cxx0x::get<0>(commons);
+  const hp::DoFHandler<dim>& dof = std_cxx0x::get<1>(commons);
+  const hp::QCollection<dim-1>& q = std_cxx0x::get<2>(commons);
   const hp::FECollection<dim,spacedim> &fe_collection = dof.get_fe();
   const unsigned int n_components  = fe_collection.n_components();
   const unsigned int n_function_components = boundary_functions.begin()->second->n_components;

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.