From 46c1aecd22ddfcc46ede040f0a56da7ef5759055 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Fri, 6 Aug 2010 03:01:08 +0000 Subject: [PATCH] Use std_cxx1x::shared_ptr instead of boost::shared_ptr. git-svn-id: https://svn.dealii.org/trunk@21615 0785d39b-7218-0410-832d-ea1e28bc413d --- .../include/numerics/mesh_worker_assembler.h | 2 +- .../include/numerics/mesh_worker_info.h | 46 +++++++++---------- .../numerics/mesh_worker_info.templates.h | 2 +- 3 files changed, 25 insertions(+), 25 deletions(-) diff --git a/deal.II/deal.II/include/numerics/mesh_worker_assembler.h b/deal.II/deal.II/include/numerics/mesh_worker_assembler.h index 387a3d2dee..44c2116f31 100644 --- a/deal.II/deal.II/include/numerics/mesh_worker_assembler.h +++ b/deal.II/deal.II/include/numerics/mesh_worker_assembler.h @@ -873,7 +873,7 @@ namespace MeshWorker { public: /// The object that is stored - typedef boost::shared_ptr > > MatrixPtr; + typedef std_cxx1x::shared_ptr > > MatrixPtr; /** * Constructor, initializing diff --git a/deal.II/deal.II/include/numerics/mesh_worker_info.h b/deal.II/deal.II/include/numerics/mesh_worker_info.h index d9d4efb272..f30554f9e5 100644 --- a/deal.II/deal.II/include/numerics/mesh_worker_info.h +++ b/deal.II/deal.II/include/numerics/mesh_worker_info.h @@ -15,7 +15,7 @@ #include #include -#include +#include #include #include #include @@ -312,7 +312,7 @@ namespace MeshWorker { private: /// vector of FEValues objects - std::vector > > fevalv; + std::vector > > fevalv; public: static const unsigned int dimension = dim; static const unsigned int space_dimension = spacedim; @@ -374,7 +374,7 @@ namespace MeshWorker * vector and cache the * selector. */ - void initialize_data(const boost::shared_ptr > &data); + void initialize_data(const std_cxx1x::shared_ptr > &data); /** * Delete the data created by initialize(). @@ -476,7 +476,7 @@ namespace MeshWorker * values in quadrature * points. */ - boost::shared_ptr > global_data; + std_cxx1x::shared_ptr > global_data; private: /** @@ -701,9 +701,9 @@ namespace MeshWorker */ MeshWorker::VectorSelector face_selector; - boost::shared_ptr > cell_data; - boost::shared_ptr > boundary_data; - boost::shared_ptr > face_data; + std_cxx1x::shared_ptr > cell_data; + std_cxx1x::shared_ptr > boundary_data; + std_cxx1x::shared_ptr > face_data; /* @} */ /** @@ -950,7 +950,7 @@ namespace MeshWorker : fevalv(0), multigrid(false), - global_data(boost::shared_ptr >(new VectorDataBase)) + global_data(std_cxx1x::shared_ptr >(new VectorDataBase)) {} @@ -974,15 +974,15 @@ namespace MeshWorker const FESubfaceValues* ps = dynamic_cast*>(&p); if (pc != 0) - fevalv[i] = boost::shared_ptr > ( + fevalv[i] = std_cxx1x::shared_ptr > ( reinterpret_cast*>( new FEValues (pc->get_mapping(), pc->get_fe(), pc->get_quadrature(), pc->get_update_flags()))); else if (pf != 0) - fevalv[i] = boost::shared_ptr > ( + fevalv[i] = std_cxx1x::shared_ptr > ( new FEFaceValues (pf->get_mapping(), pf->get_fe(), pf->get_quadrature(), pf->get_update_flags())); else if (ps != 0) - fevalv[i] = boost::shared_ptr > ( + fevalv[i] = std_cxx1x::shared_ptr > ( new FESubfaceValues (ps->get_mapping(), ps->get_fe(), ps->get_quadrature(), ps->get_update_flags())); else Assert(false, ExcInternalError()); @@ -1013,7 +1013,7 @@ namespace MeshWorker const FESubfaceValues* ps = dynamic_cast*>(&p); if (pc != 0) - fevalv[i] = boost::shared_ptr > ( + fevalv[i] = std_cxx1x::shared_ptr > ( reinterpret_cast*>( new FEValues (pc->get_mapping(), pc->get_fe(), pc->get_quadrature(), pc->get_update_flags()))); @@ -1056,7 +1056,7 @@ namespace MeshWorker const FESubfaceValues* ps = dynamic_cast*>(&p); if (pc != 0) - fevalv[i] = boost::shared_ptr > ( + fevalv[i] = std_cxx1x::shared_ptr > ( reinterpret_cast*>( new FEValues (pc->get_mapping(), pc->get_fe(), pc->get_quadrature(), pc->get_update_flags()))); @@ -1090,7 +1090,7 @@ namespace MeshWorker if (block_info == 0 || block_info->local().size() == 0) { fevalv.resize(1); - fevalv[0] = boost::shared_ptr > ( + fevalv[0] = std_cxx1x::shared_ptr > ( new FEVALUES (mapping, el, quadrature, flags)); } else @@ -1098,7 +1098,7 @@ namespace MeshWorker fevalv.resize(el.n_base_elements()); for (unsigned int i=0;i > ( + fevalv[i] = std_cxx1x::shared_ptr > ( new FEVALUES (mapping, el.base_element(i), quadrature, flags)); } } @@ -1291,19 +1291,19 @@ namespace MeshWorker const BlockInfo* block_info) { initialize(el, mapping, block_info); - boost::shared_ptr > p; + std_cxx1x::shared_ptr > p; - p = boost::shared_ptr >(new VectorData (cell_selector)); + p = std_cxx1x::shared_ptr >(new VectorData (cell_selector)); p->initialize(data); cell_data = p; cell.initialize_data(p); - p = boost::shared_ptr >(new VectorData (boundary_selector)); + p = std_cxx1x::shared_ptr >(new VectorData (boundary_selector)); p->initialize(data); boundary_data = p; boundary.initialize_data(p); - p = boost::shared_ptr >(new VectorData (face_selector)); + p = std_cxx1x::shared_ptr >(new VectorData (face_selector)); p->initialize(data); face_data = p; face.initialize_data(p); @@ -1322,19 +1322,19 @@ namespace MeshWorker const BlockInfo* block_info) { initialize(el, mapping, block_info); - boost::shared_ptr > p; + std_cxx1x::shared_ptr > p; - p = boost::shared_ptr >(new MGVectorData (cell_selector)); + p = std_cxx1x::shared_ptr >(new MGVectorData (cell_selector)); p->initialize(data); cell_data = p; cell.initialize_data(p); - p = boost::shared_ptr >(new MGVectorData (boundary_selector)); + p = std_cxx1x::shared_ptr >(new MGVectorData (boundary_selector)); p->initialize(data); boundary_data = p; boundary.initialize_data(p); - p = boost::shared_ptr >(new MGVectorData (face_selector)); + p = std_cxx1x::shared_ptr >(new MGVectorData (face_selector)); p->initialize(data); face_data = p; face.initialize_data(p); diff --git a/deal.II/deal.II/include/numerics/mesh_worker_info.templates.h b/deal.II/deal.II/include/numerics/mesh_worker_info.templates.h index bf0dfd398d..0fb6456c03 100644 --- a/deal.II/deal.II/include/numerics/mesh_worker_info.templates.h +++ b/deal.II/deal.II/include/numerics/mesh_worker_info.templates.h @@ -79,7 +79,7 @@ namespace MeshWorker template void IntegrationInfo::initialize_data( - const boost::shared_ptr > &data) + const std_cxx1x::shared_ptr > &data) { global_data = data; const unsigned int nqp = fevalv[0]->n_quadrature_points; -- 2.39.5