From: Wolfgang Bangerth Date: Tue, 13 Jan 2009 03:59:46 +0000 (+0000) Subject: Use namespace std_cxx0x where appropriate. The only place where we don't is where... X-Git-Tag: v8.0.0~8133 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=51050e5db12e146bd23cb9d5887640a9d001210b;p=dealii.git Use namespace std_cxx0x where appropriate. The only place where we don't is where we use boost::graph, which isn't going to be part of C++0x as far as I know. git-svn-id: https://svn.dealii.org/trunk@18197 0785d39b-7218-0410-832d-ea1e28bc413d --- 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 index 0000000000..925aae66d1 --- /dev/null +++ b/deal.II/base/include/base/std_cxx0x/array.h @@ -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 +#include + + +DEAL_II_NAMESPACE_OPEN + +namespace std_cxx0x +{ + using boost::array; +} + + +DEAL_II_NAMESPACE_CLOSE + +#endif diff --git a/deal.II/base/include/base/std_cxx0x/tuple.h b/deal.II/base/include/base/std_cxx0x/tuple.h index 20cd02976b..86ecd219ec 100644 --- a/deal.II/base/include/base/std_cxx0x/tuple.h +++ b/deal.II/base/include/base/std_cxx0x/tuple.h @@ -23,6 +23,8 @@ DEAL_II_NAMESPACE_OPEN namespace std_cxx0x { using boost::tuple; + using boost::get; + namespace tuples { using namespace boost::tuples; diff --git a/deal.II/deal.II/include/hp/fe_collection.h b/deal.II/deal.II/include/hp/fe_collection.h index d9f839b433..46fc51f960 100644 --- a/deal.II/deal.II/include/hp/fe_collection.h +++ b/deal.II/deal.II/include/hp/fe_collection.h @@ -14,7 +14,7 @@ #define __deal2__fe_collection_h #include -#include +#include #include DEAL_II_NAMESPACE_OPEN @@ -215,7 +215,7 @@ namespace hp * Array of pointers to the finite * elements stored by this collection. */ - std::vector > > finite_elements; + std::vector > > finite_elements; }; diff --git a/deal.II/deal.II/include/hp/fe_values.h b/deal.II/deal.II/include/hp/fe_values.h index 4cfde4c097..b09f2fc261 100644 --- a/deal.II/deal.II/include/hp/fe_values.h +++ b/deal.II/deal.II/include/hp/fe_values.h @@ -21,7 +21,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -163,7 +163,7 @@ namespace internal * as needed in * select_fe_values(). */ - Table<3,boost::shared_ptr > fe_values_table; + Table<3,std_cxx0x::shared_ptr > fe_values_table; /** * Set of indices pointing at diff --git a/deal.II/deal.II/include/hp/mapping_collection.h b/deal.II/deal.II/include/hp/mapping_collection.h index 496c2eed3b..0b4769f6e8 100644 --- a/deal.II/deal.II/include/hp/mapping_collection.h +++ b/deal.II/deal.II/include/hp/mapping_collection.h @@ -19,7 +19,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -128,7 +128,7 @@ namespace hp * pointers to the different Mapping * objects. */ - std::vector > > mappings; + std::vector > > mappings; }; diff --git a/deal.II/deal.II/include/hp/q_collection.h b/deal.II/deal.II/include/hp/q_collection.h index 55d97d5105..2b89c396e6 100644 --- a/deal.II/deal.II/include/hp/q_collection.h +++ b/deal.II/deal.II/include/hp/q_collection.h @@ -21,7 +21,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -146,7 +146,7 @@ namespace hp * pointers to the different quadrature * objects. */ - std::vector > > quadratures; + std::vector > > quadratures; }; @@ -205,7 +205,7 @@ namespace hp QCollection::QCollection (const Quadrature &quadrature) { quadratures - .push_back (boost::shared_ptr >(new Quadrature(quadrature))); + .push_back (std_cxx0x::shared_ptr >(new Quadrature(quadrature))); } @@ -248,7 +248,7 @@ namespace hp QCollection::push_back (const Quadrature &new_quadrature) { quadratures - .push_back (boost::shared_ptr >(new Quadrature(new_quadrature))); + .push_back (std_cxx0x::shared_ptr >(new Quadrature(new_quadrature))); } } // namespace hp diff --git a/deal.II/deal.II/include/multigrid/mg_level_object.h b/deal.II/deal.II/include/multigrid/mg_level_object.h index 6cf3501f72..2110d061b8 100644 --- a/deal.II/deal.II/include/multigrid/mg_level_object.h +++ b/deal.II/deal.II/include/multigrid/mg_level_object.h @@ -16,7 +16,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -113,7 +113,7 @@ class MGLevelObject : public Subscriptor /** * Array of the objects to be held. */ - std::vector > objects; + std::vector > objects; }; /*@}*/ @@ -165,7 +165,7 @@ MGLevelObject::resize (const unsigned int new_minlevel, minlevel = new_minlevel; for (unsigned int i=0; i (new Object)); + objects.push_back(std_cxx0x::shared_ptr (new Object)); } @@ -173,7 +173,7 @@ template MGLevelObject & MGLevelObject::operator = (const double d) { - typename std::vector >::iterator v; + typename std::vector >::iterator v; for (v = objects.begin(); v != objects.end(); ++v) **v=d; return *this; @@ -184,7 +184,7 @@ template void MGLevelObject::clear () { - typename std::vector >::iterator v; + typename std::vector >::iterator v; for (v = objects.begin(); v != objects.end(); ++v) (*v)->clear(); } @@ -211,7 +211,7 @@ unsigned int MGLevelObject::memory_consumption () const { unsigned int result = sizeof(*this); - typedef typename std::vector >::const_iterator Iter; + typedef typename std::vector >::const_iterator Iter; const Iter end = objects.end(); for (Iter o=objects.begin(); o!=end; ++o) result += (*o)->memory_consumption(); diff --git a/deal.II/deal.II/include/multigrid/mg_transfer.h b/deal.II/deal.II/include/multigrid/mg_transfer.h index a7a2163993..8108c423a6 100644 --- a/deal.II/deal.II/include/multigrid/mg_transfer.h +++ b/deal.II/deal.II/include/multigrid/mg_transfer.h @@ -32,7 +32,7 @@ #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -156,7 +156,7 @@ class MGTransferPrebuilt : public MGTransferBase * Sparsity patterns for transfer * matrices. */ - std::vector > prolongation_sparsities; + std::vector > prolongation_sparsities; /** * The actual prolongation matrix. @@ -166,7 +166,7 @@ class MGTransferPrebuilt : public MGTransferBase * while row indices belong to the * child cell, i.e. the fine level. */ - std::vector > > prolongation_matrices; + std::vector > > prolongation_matrices; /** * Mapping for the diff --git a/deal.II/deal.II/include/multigrid/mg_transfer.templates.h b/deal.II/deal.II/include/multigrid/mg_transfer.templates.h index defcfc4b3d..0660168b79 100644 --- a/deal.II/deal.II/include/multigrid/mg_transfer.templates.h +++ b/deal.II/deal.II/include/multigrid/mg_transfer.templates.h @@ -95,8 +95,8 @@ MGTransferPrebuilt::memory_consumption () const unsigned int result = sizeof(*this); result += sizeof(unsigned int) * sizes.size(); #ifdef DEAL_PREFER_MATRIX_EZ - std::vector > >::const_iterator m; - const std::vector > >::const_iterator end = prolongation_matrices.end(); + std::vector > >::const_iterator m; + const std::vector > >::const_iterator end = prolongation_matrices.end(); for (m = prolongation_matrices.begin(); m != end ; ++m) result += *m->memory_consumption(); #else diff --git a/deal.II/deal.II/include/multigrid/mg_transfer_block.h b/deal.II/deal.II/include/multigrid/mg_transfer_block.h index 11f6f99117..09f959cc73 100644 --- a/deal.II/deal.II/include/multigrid/mg_transfer_block.h +++ b/deal.II/deal.II/include/multigrid/mg_transfer_block.h @@ -33,7 +33,7 @@ #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -133,7 +133,7 @@ class MGTransferBlockBase DeclException0(ExcMatricesNotBuilt); private: - std::vector > prolongation_sparsities; + std::vector > prolongation_sparsities; protected: @@ -145,7 +145,7 @@ class MGTransferBlockBase * while row indices belong to the * child cell, i.e. the fine level. */ - std::vector > > prolongation_matrices; + std::vector > > prolongation_matrices; /** * Mapping for the diff --git a/deal.II/deal.II/include/multigrid/mg_transfer_component.h b/deal.II/deal.II/include/multigrid/mg_transfer_component.h index 6384012c21..4376ad64e8 100644 --- a/deal.II/deal.II/include/multigrid/mg_transfer_component.h +++ b/deal.II/deal.II/include/multigrid/mg_transfer_component.h @@ -32,7 +32,7 @@ #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -149,7 +149,7 @@ class MGTransferComponentBase DeclException0(ExcMatricesNotBuilt); private: - std::vector > prolongation_sparsities; + std::vector > prolongation_sparsities; protected: @@ -161,7 +161,7 @@ class MGTransferComponentBase * while row indices belong to the * child cell, i.e. the fine level. */ - std::vector > > prolongation_matrices; + std::vector > > prolongation_matrices; /** * Unused now, but intended to diff --git a/deal.II/deal.II/include/numerics/data_out.h b/deal.II/deal.II/include/numerics/data_out.h index ca48ba1d90..c66039677d 100644 --- a/deal.II/deal.II/include/numerics/data_out.h +++ b/deal.II/deal.II/include/numerics/data_out.h @@ -24,7 +24,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -1002,13 +1002,13 @@ class DataOut_DoFData : public DataOutInterface * List of data elements with vectors of * values for each degree of freedom. */ - std::vector > dof_data; + std::vector > dof_data; /** * List of data elements with vectors of * values for each cell. */ - std::vector > cell_data; + std::vector > cell_data; /** * This is a list of patches that is @@ -1044,7 +1044,7 @@ class DataOut_DoFData : public DataOutInterface * extensive documentation. */ virtual - std::vector > + std::vector > get_vector_data_ranges () const; /** diff --git a/deal.II/deal.II/include/numerics/matrices.h b/deal.II/deal.II/include/numerics/matrices.h index 1fd1f6b784..9a1e465915 100644 --- a/deal.II/deal.II/include/numerics/matrices.h +++ b/deal.II/deal.II/include/numerics/matrices.h @@ -795,7 +795,7 @@ class MatrixCreator */ template static - void create_boundary_mass_matrix_1 (boost::tuple &, + void create_boundary_mass_matrix_1 (std_cxx0x::tuple &, const DoFHandler &, const Quadrature & > commons, SparseMatrix &matrix, @@ -812,7 +812,7 @@ class MatrixCreator */ template static - void create_boundary_mass_matrix_1 (boost::tuple &, + void create_boundary_mass_matrix_1 (std_cxx0x::tuple &, const hp::DoFHandler&, const hp::QCollection & > commons, SparseMatrix &matrix, diff --git a/deal.II/deal.II/source/dofs/dof_tools.cc b/deal.II/deal.II/source/dofs/dof_tools.cc index 1c38e13248..4237e0c605 100644 --- a/deal.II/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/deal.II/source/dofs/dof_tools.cc @@ -1332,11 +1332,11 @@ namespace internal ensure_existence_of_master_dof_mask (const FiniteElement &fe1, const FiniteElement &fe2, const FullMatrix &face_interpolation_matrix, - boost::shared_ptr > &master_dof_mask) + std_cxx0x::shared_ptr > &master_dof_mask) { if (master_dof_mask == 0) { - master_dof_mask = boost::shared_ptr > + master_dof_mask = std_cxx0x::shared_ptr > (new std::vector (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 &fe1, const FiniteElement &fe2, - boost::shared_ptr > &matrix) + std_cxx0x::shared_ptr > &matrix) { if (matrix == 0) { - matrix = boost::shared_ptr > + matrix = std_cxx0x::shared_ptr > (new FullMatrix (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 &fe1, const FiniteElement &fe2, const unsigned int subface, - boost::shared_ptr > &matrix) + std_cxx0x::shared_ptr > &matrix) { if (matrix == 0) { - matrix = boost::shared_ptr > + matrix = std_cxx0x::shared_ptr > (new FullMatrix (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 &face_interpolation_matrix, const std::vector &master_dof_mask, - boost::shared_ptr,FullMatrix > > &split_matrix) + std_cxx0x::shared_ptr,FullMatrix > > &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,FullMatrix > > + = std_cxx0x::shared_ptr,FullMatrix > > (new std::pair,FullMatrix >()); 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 > > + Table<2,std_cxx0x::shared_ptr > > face_interpolation_matrices (n_finite_elements (dof_handler), n_finite_elements (dof_handler)); - Table<3,boost::shared_ptr > > + Table<3,std_cxx0x::shared_ptr > > subface_interpolation_matrices (n_finite_elements (dof_handler), n_finite_elements (dof_handler), GeometryInfo::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,FullMatrix > > > + Table<2,std_cxx0x::shared_ptr,FullMatrix > > > 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 > > + Table<2,std_cxx0x::shared_ptr > > master_dof_masks (n_finite_elements (dof_handler), n_finite_elements (dof_handler)); diff --git a/deal.II/deal.II/source/fe/fe_tools.cc b/deal.II/deal.II/source/fe/fe_tools.cc index 592b4bc017..eb5b92a437 100644 --- a/deal.II/deal.II/source/fe/fe_tools.cc +++ b/deal.II/deal.II/source/fe/fe_tools.cc @@ -45,7 +45,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -60,7 +60,7 @@ namespace // apparent memory leaks to // programs like valgrind typedef - boost::shared_ptr > + std_cxx0x::shared_ptr > FEFactoryPointer; // a function that returns the @@ -142,7 +142,7 @@ namespace // issues here static std::map > > + std_cxx0x::shared_ptr > > fe_name_map = get_default_fe_names (); } @@ -1071,7 +1071,7 @@ FETools::interpolate (const DH1 &dof1, // that memory is released again std::map *, std::map *, - boost::shared_ptr > > > + std_cxx0x::shared_ptr > > > interpolation_matrices; typename DH1::active_cell_iterator cell1 = dof1.begin_active(), @@ -1119,7 +1119,7 @@ FETools::interpolate (const DH1 &dof1, // there if (interpolation_matrices[&cell1->get_fe()][&cell2->get_fe()] == 0) { - boost::shared_ptr > + std_cxx0x::shared_ptr > interpolation_matrix (new FullMatrix (dofs_per_cell2, dofs_per_cell1)); interpolation_matrices[&cell1->get_fe()][&cell2->get_fe()] @@ -1236,7 +1236,7 @@ FETools::back_interpolate(const DH &dof1, // dof1 to the back_interpolation // matrices std::map *, - boost::shared_ptr > > interpolation_matrices; + std_cxx0x::shared_ptr > > interpolation_matrices; for (; cell!=endc; ++cell) { @@ -1267,7 +1267,7 @@ FETools::back_interpolate(const DH &dof1, if (interpolation_matrices[&cell->get_fe()] != 0) { interpolation_matrices[&cell->get_fe()] = - boost::shared_ptr > + std_cxx0x::shared_ptr > (new FullMatrix(dofs_per_cell1, dofs_per_cell1)); get_back_interpolation_matrix(dof1.get_fe(), fe2, *interpolation_matrices[&cell->get_fe()]); diff --git a/deal.II/deal.II/source/grid/tria.cc b/deal.II/deal.II/source/grid/tria.cc index 8c1f76a9c1..8ab7b2204a 100644 --- a/deal.II/deal.II/source/grid/tria.cc +++ b/deal.II/deal.II/source/grid/tria.cc @@ -31,7 +31,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -1951,7 +1951,7 @@ namespace internal // this file std::map, std::pair::quad_iterator, - boost::array::lines_per_face> >, + std_cxx0x::array::lines_per_face> >, QuadComparator> needed_quads; for (unsigned int cell=0; cell line_list[GeometryInfo::lines_per_cell], inverse_line_list[GeometryInfo::lines_per_cell]; unsigned int face_line_list[GeometryInfo::lines_per_face]; - boost::array::lines_per_face> orientation; + std_cxx0x::array::lines_per_face> orientation; for (unsigned int line=0; line::lines_per_cell; ++line) { @@ -2103,7 +2103,7 @@ namespace internal quad = triangulation.begin_raw_quad(); typename std::map, std::pair::quad_iterator, - boost::array::lines_per_face> >, + std_cxx0x::array::lines_per_face> >, QuadComparator> ::iterator q; for (q = needed_quads.begin(); quad!=triangulation.end_quad(); ++quad, ++q) diff --git a/deal.II/deal.II/source/hp/dof_handler.cc b/deal.II/deal.II/source/hp/dof_handler.cc index 1f673e7f00..3bfe376926 100644 --- a/deal.II/deal.II/source/hp/dof_handler.cc +++ b/deal.II/deal.II/source/hp/dof_handler.cc @@ -58,7 +58,7 @@ namespace internal void ensure_existence_of_dof_identities (const FiniteElement &fe1, const FiniteElement &fe2, - boost::shared_ptr &identities) + std_cxx0x::shared_ptr &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 + std_cxx0x::shared_ptr (new DoFIdentities(fe1.hp_vertex_dof_identities(fe2))); break; } @@ -78,7 +78,7 @@ namespace internal case 1: { identities = - boost::shared_ptr + std_cxx0x::shared_ptr (new DoFIdentities(fe1.hp_line_dof_identities(fe2))); break; } @@ -86,7 +86,7 @@ namespace internal case 2: { identities = - boost::shared_ptr + std_cxx0x::shared_ptr (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 > + Table<2,std_cxx0x::shared_ptr > 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 > + Table<2,std_cxx0x::shared_ptr > 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 > + Table<2,std_cxx0x::shared_ptr > quad_dof_identities (finite_elements->size(), finite_elements->size()); diff --git a/deal.II/deal.II/source/hp/fe_collection.cc b/deal.II/deal.II/source/hp/fe_collection.cc index 8593aa1974..a0ecc88360 100644 --- a/deal.II/deal.II/source/hp/fe_collection.cc +++ b/deal.II/deal.II/source/hp/fe_collection.cc @@ -67,7 +67,7 @@ namespace hp "same number of vector components!")); finite_elements - .push_back (boost::shared_ptr >(new_fe.clone())); + .push_back (std_cxx0x::shared_ptr >(new_fe.clone())); } diff --git a/deal.II/deal.II/source/hp/fe_values.cc b/deal.II/deal.II/source/hp/fe_values.cc index 13a2d535e3..5715f34a36 100644 --- a/deal.II/deal.II/source/hp/fe_values.cc +++ b/deal.II/deal.II/source/hp/fe_values.cc @@ -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 + std_cxx0x::shared_ptr (new FEValues ((*mapping_collection)[mapping_index], (*fe_collection)[fe_index], q_collection[q_index], diff --git a/deal.II/deal.II/source/hp/mapping_collection.cc b/deal.II/deal.II/source/hp/mapping_collection.cc index 29fc3080bc..010b7adef5 100644 --- a/deal.II/deal.II/source/hp/mapping_collection.cc +++ b/deal.II/deal.II/source/hp/mapping_collection.cc @@ -31,7 +31,7 @@ namespace hp MappingCollection (const Mapping &mapping) { mappings - .push_back (boost::shared_ptr >(mapping.clone())); + .push_back (std_cxx0x::shared_ptr >(mapping.clone())); } @@ -72,7 +72,7 @@ namespace hp MappingCollection::push_back (const Mapping &new_mapping) { mappings - .push_back (boost::shared_ptr >(new_mapping.clone())); + .push_back (std_cxx0x::shared_ptr >(new_mapping.clone())); } //--------------------------------------------------------------------------- diff --git a/deal.II/deal.II/source/multigrid/mg_transfer_block.cc b/deal.II/deal.II/source/multigrid/mg_transfer_block.cc index b7f6423fe4..b1eeab278e 100644 --- a/deal.II/deal.II/source/multigrid/mg_transfer_block.cc +++ b/deal.II/deal.II/source/multigrid/mg_transfer_block.cc @@ -116,9 +116,9 @@ void MGTransferBlockBase::build_matrices ( for (unsigned int i=0; i (new BlockSparsityPattern)); + .push_back (std_cxx0x::shared_ptr (new BlockSparsityPattern)); prolongation_matrices - .push_back (boost::shared_ptr > (new BlockSparseMatrix)); + .push_back (std_cxx0x::shared_ptr > (new BlockSparseMatrix)); } // two fields which will store the diff --git a/deal.II/deal.II/source/multigrid/mg_transfer_component.cc b/deal.II/deal.II/source/multigrid/mg_transfer_component.cc index f068b66e8a..96eb06b3f0 100644 --- a/deal.II/deal.II/source/multigrid/mg_transfer_component.cc +++ b/deal.II/deal.II/source/multigrid/mg_transfer_component.cc @@ -152,9 +152,9 @@ void MGTransferComponentBase::build_matrices ( for (unsigned int i=0; i (new BlockSparsityPattern)); + .push_back (std_cxx0x::shared_ptr (new BlockSparsityPattern)); prolongation_matrices - .push_back (boost::shared_ptr > (new BlockSparseMatrix)); + .push_back (std_cxx0x::shared_ptr > (new BlockSparseMatrix)); } // two fields which will store the diff --git a/deal.II/deal.II/source/multigrid/mg_transfer_prebuilt.cc b/deal.II/deal.II/source/multigrid/mg_transfer_prebuilt.cc index b2fd0fd45f..5500767d1e 100644 --- a/deal.II/deal.II/source/multigrid/mg_transfer_prebuilt.cc +++ b/deal.II/deal.II/source/multigrid/mg_transfer_prebuilt.cc @@ -58,9 +58,9 @@ void MGTransferPrebuilt::build_matrices ( for (unsigned int i=0; i (new SparsityPattern)); + .push_back (std_cxx0x::shared_ptr (new SparsityPattern)); prolongation_matrices - .push_back (boost::shared_ptr > (new SparseMatrix)); + .push_back (std_cxx0x::shared_ptr > (new SparseMatrix)); } // two fields which will store the diff --git a/deal.II/deal.II/source/numerics/data_out.cc b/deal.II/deal.II/source/numerics/data_out.cc index 9e4dcf74d9..438c9ab8d6 100644 --- a/deal.II/deal.II/source/numerics/data_out.cc +++ b/deal.II/deal.II/source/numerics/data_out.cc @@ -385,9 +385,9 @@ add_data_vector (const VECTOR &vec, DataEntryBase * new_entry = new DataEntry(&vec, names, data_component_interpretation); if (actual_type == type_dof_data) - dof_data.push_back (boost::shared_ptr(new_entry)); + dof_data.push_back (std_cxx0x::shared_ptr(new_entry)); else - cell_data.push_back (boost::shared_ptr(new_entry)); + cell_data.push_back (std_cxx0x::shared_ptr(new_entry)); } @@ -416,7 +416,7 @@ add_data_vector (const VECTOR &vec, dofs->get_tria().n_active_cells())); DataEntryBase * new_entry = new DataEntry(&vec, &data_postprocessor); - dof_data.push_back (boost::shared_ptr(new_entry)); + dof_data.push_back (std_cxx0x::shared_ptr(new_entry)); } @@ -481,7 +481,7 @@ get_dataset_names () const // collect the names of dof // and cell data typedef - typename std::vector >::const_iterator + typename std::vector >::const_iterator data_iterator; for (data_iterator d=dof_data.begin(); @@ -501,16 +501,16 @@ get_dataset_names () const template -std::vector > +std::vector > DataOut_DoFData::get_vector_data_ranges () const { - std::vector > + std::vector > ranges; // collect the ranges of dof // and cell data typedef - typename std::vector >::const_iterator + typename std::vector >::const_iterator data_iterator; unsigned int output_component = 0; @@ -556,7 +556,7 @@ DataOut_DoFData::get_vector_data_ranges () const // finally add a corresponding // range - boost::tuple + std_cxx0x::tuple range (output_component, output_component+patch_space_dim-1, name); diff --git a/deal.II/deal.II/source/numerics/matrices.cc b/deal.II/deal.II/source/numerics/matrices.cc index 3c650dbe09..5512ee9061 100644 --- a/deal.II/deal.II/source/numerics/matrices.cc +++ b/deal.II/deal.II/source/numerics/matrices.cc @@ -1080,7 +1080,7 @@ MatrixCreator::create_boundary_mass_matrix (const Mapping &mappi // the matrix Threads::ThreadMutex mutex; - typedef boost::tuple&, + typedef std_cxx0x::tuple&, const DoFHandler&, const Quadrature&> Commons; @@ -1111,7 +1111,7 @@ MatrixCreator::create_boundary_mass_matrix (const Mapping &mappi template <> void MatrixCreator:: -create_boundary_mass_matrix_1<2,3> (boost::tuple &, +create_boundary_mass_matrix_1<2,3> (std_cxx0x::tuple &, const DoFHandler<2,3> &, const Quadrature<1> & > , SparseMatrix &, @@ -1132,7 +1132,7 @@ create_boundary_mass_matrix_1<2,3> (boost::tuple &, template void MatrixCreator:: -create_boundary_mass_matrix_1 (boost::tuple &, +create_boundary_mass_matrix_1 (std_cxx0x::tuple &, const DoFHandler &, const Quadrature & > commons, SparseMatrix &matrix, @@ -1147,9 +1147,9 @@ create_boundary_mass_matrix_1 (boost::tuple &, // All assertions for this function // are in the calling function // before creating threads. - const Mapping& mapping = boost::get<0>(commons); - const DoFHandler& dof = boost::get<1>(commons); - const Quadrature& q = boost::get<2>(commons); + const Mapping& mapping = std_cxx0x::get<0>(commons); + const DoFHandler& dof = std_cxx0x::get<1>(commons); + const Quadrature& q = std_cxx0x::get<2>(commons); const FiniteElement &fe = dof.get_fe(); const unsigned int n_components = fe.n_components(); @@ -1482,7 +1482,7 @@ MatrixCreator::create_boundary_mass_matrix (const hp::MappingCollection (dof.begin_active(), dof.end(), n_threads); - typedef boost::tuple&, + typedef std_cxx0x::tuple&, const hp::DoFHandler&, const hp::QCollection&> Commons; @@ -1516,7 +1516,7 @@ MatrixCreator::create_boundary_mass_matrix (const hp::MappingCollection void MatrixCreator:: -create_boundary_mass_matrix_1 (boost::tuple &, +create_boundary_mass_matrix_1 (std_cxx0x::tuple &, const hp::DoFHandler &, const hp::QCollection &> commons, SparseMatrix &matrix, @@ -1528,9 +1528,9 @@ create_boundary_mass_matrix_1 (boost::tuple > range, Threads::ThreadMutex &mutex) { - const hp::MappingCollection& mapping = boost::get<0>(commons); - const hp::DoFHandler& dof = boost::get<1>(commons); - const hp::QCollection& q = boost::get<2>(commons); + const hp::MappingCollection& mapping = std_cxx0x::get<0>(commons); + const hp::DoFHandler& dof = std_cxx0x::get<1>(commons); + const hp::QCollection& q = std_cxx0x::get<2>(commons); const hp::FECollection &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;