From: turcksin Date: Thu, 28 Feb 2013 23:12:22 +0000 (+0000) Subject: Convert unsigned int to types::global_dof_index. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=0dab7923376e12b07d05dc1e0420ae27a7371908;p=dealii-svn.git Convert unsigned int to types::global_dof_index. git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28653 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/base/index_set.h b/deal.II/include/deal.II/base/index_set.h index 4d650aafc4..6fe0a6b2ed 100644 --- a/deal.II/include/deal.II/base/index_set.h +++ b/deal.II/include/deal.II/base/index_set.h @@ -908,8 +908,8 @@ IndexSet::nth_index_in_set (const unsigned int n) const inline -types::global_dof_index -IndexSet::index_within_set (const unsigned int n) const +unsigned int +IndexSet::index_within_set (const types::global_dof_index n) const { // to make this call thread-safe, compress() // must not be called through this function diff --git a/deal.II/include/deal.II/base/memory_consumption.h b/deal.II/include/deal.II/base/memory_consumption.h index 619e3ba5d9..e9c854c4c6 100644 --- a/deal.II/include/deal.II/base/memory_consumption.h +++ b/deal.II/include/deal.II/base/memory_consumption.h @@ -152,6 +152,14 @@ namespace MemoryConsumption inline std::size_t memory_consumption (const unsigned int); + /** + * Determine the amount of memory + * in bytes consumed by a unsigned long long int + * variable. + */ + inline + std::size_t memory_consumption (const unsigned long long int); + /** * Determine the amount of memory * in bytes consumed by a float @@ -459,7 +467,7 @@ namespace MemoryConsumption { return sizeof(int); } - + inline @@ -468,6 +476,14 @@ namespace MemoryConsumption return sizeof(unsigned int); } + + + inline + std::size_t memory_consumption (const unsigned long long int) + { + return sizeof(unsigned long long int); + } + inline diff --git a/deal.II/include/deal.II/dofs/dof_accessor.templates.h b/deal.II/include/deal.II/dofs/dof_accessor.templates.h index 3cac193055..9c49af18e8 100644 --- a/deal.II/include/deal.II/dofs/dof_accessor.templates.h +++ b/deal.II/include/deal.II/dofs/dof_accessor.templates.h @@ -1434,7 +1434,7 @@ namespace internal static void set_mg_dof_indices (const dealii::DoFAccessor<1,DH,lda> &, const int, - const std::vector &, + const std::vector &, const unsigned int) { AssertThrow (false, ExcNotImplemented ()); //TODO[TH]: implement @@ -1446,11 +1446,11 @@ namespace internal static void set_mg_dof_indices (dealii::DoFAccessor<2, DH,lda> &accessor, const int level, - const std::vector &dof_indices, + const std::vector &dof_indices, const unsigned int fe_index) { const FiniteElement &fe = accessor.get_dof_handler ().get_fe ()[fe_index]; - std::vector::const_iterator next = dof_indices.begin (); + std::vector::const_iterator next = dof_indices.begin (); for (unsigned int vertex = 0; vertex < GeometryInfo<2>::vertices_per_cell; ++vertex) for (unsigned int dof = 0; dof < fe.dofs_per_vertex; ++dof) @@ -1472,7 +1472,7 @@ namespace internal static void set_mg_dof_indices (const dealii::DoFAccessor<3, DH,lda> &, const int, - const std::vector &, + const std::vector &, const unsigned int) { AssertThrow (false, ExcNotImplemented ()); //TODO[TH]: implement @@ -3547,7 +3547,7 @@ DoFCellAccessor::face (const unsigned int i) const template inline void -DoFCellAccessor::get_dof_indices (std::vector &dof_indices) const +DoFCellAccessor::get_dof_indices (std::vector &dof_indices) const { Assert (this->is_artificial() == false, ExcMessage ("Can't ask for DoF indices on artificial cells.")); diff --git a/deal.II/include/deal.II/dofs/dof_handler.h b/deal.II/include/deal.II/dofs/dof_handler.h index 747665d0dc..0c3e86b613 100644 --- a/deal.II/include/deal.II/dofs/dof_handler.h +++ b/deal.II/include/deal.II/dofs/dof_handler.h @@ -232,7 +232,7 @@ public: * certain value, but rather take * its symbolic name. */ - static const unsigned int invalid_dof_index = numbers::invalid_unsigned_int; + static const types::global_dof_index invalid_dof_index = numbers::invalid_dof_index; /** * The default index of the @@ -1082,7 +1082,7 @@ DoFHandler::n_dofs () const template inline -unsigned int DoFHandler::n_dofs (const unsigned int level) const +types::global_dof_index DoFHandler::n_dofs (const unsigned int level) const { Assert(has_level_dofs(), ExcMessage("n_dofs(level) can only be called after distribute_mg_dofs()")); Assert (level < mg_number_cache.size (), ExcInvalidLevel (level)); @@ -1231,7 +1231,7 @@ void DoFHandler::load (Archive &ar, template inline -unsigned int DoFHandler::MGVertexDoFs::get_index ( +types::global_dof_index DoFHandler::MGVertexDoFs::get_index ( const unsigned int level, const unsigned int dof_number) const { @@ -1245,7 +1245,7 @@ inline void DoFHandler::MGVertexDoFs::set_index ( const unsigned int level, const unsigned int dof_number, - const unsigned int index) + const types::global_dof_index index) { Assert ((level >= coarsest_level) && (level <= finest_level), ExcInvalidLevel (level)); indices[indices_offset[level - coarsest_level] + dof_number] = index; diff --git a/deal.II/include/deal.II/dofs/dof_objects.h b/deal.II/include/deal.II/dofs/dof_objects.h index 66ed7f8315..f7e7eb8302 100644 --- a/deal.II/include/deal.II/dofs/dof_objects.h +++ b/deal.II/include/deal.II/dofs/dof_objects.h @@ -192,7 +192,7 @@ namespace internal inline unsigned int DoFObjects::n_active_fe_indices (const dealii::DoFHandler &, - const unsigned) const + const types::global_dof_index) const { return 1; } diff --git a/deal.II/include/deal.II/fe/fe_base.h b/deal.II/include/deal.II/fe/fe_base.h index ddd8e1565d..0ad4a65f86 100644 --- a/deal.II/include/deal.II/fe/fe_base.h +++ b/deal.II/include/deal.II/fe/fe_base.h @@ -206,13 +206,13 @@ public: /** * Number of degrees of freedom on a vertex. */ - const unsigned int dofs_per_vertex; + const types::global_dof_index dofs_per_vertex; /** * Number of degrees of freedom in a line; not including the degrees of * freedom on the vertices of the line. */ - const unsigned int dofs_per_line; + const types::global_dof_index dofs_per_line; /** * Number of degrees of freedom in a quadrilateral; not including the diff --git a/deal.II/include/deal.II/fe/fe_values.h b/deal.II/include/deal.II/fe/fe_values.h index 85eab8712c..abb1dcfed0 100644 --- a/deal.II/include/deal.II/fe/fe_values.h +++ b/deal.II/include/deal.II/fe/fe_values.h @@ -4783,7 +4783,7 @@ inline void FEValuesBase::get_function_grads ( const InputVector &fe_function, - const VectorSlice > &indices, + const VectorSlice > &indices, std::vector > &values) const { get_function_gradients(fe_function, indices, values); @@ -4810,7 +4810,7 @@ inline void FEValuesBase::get_function_grads ( const InputVector &fe_function, - const VectorSlice > &indices, + const VectorSlice > &indices, std::vector > > &values, bool q_points_fastest) const { diff --git a/deal.II/include/deal.II/hp/dof_handler.h b/deal.II/include/deal.II/hp/dof_handler.h index f4136f5c43..751da3e0c4 100644 --- a/deal.II/include/deal.II/hp/dof_handler.h +++ b/deal.II/include/deal.II/hp/dof_handler.h @@ -454,7 +454,7 @@ namespace hp * cells are also not necessarily * included. */ - unsigned int n_locally_owned_dofs() const; + types::global_dof_index n_locally_owned_dofs() const; /** * Return an IndexSet describing @@ -512,7 +512,7 @@ namespace hp * then the vector has a single * element equal to n_dofs(). */ - const std::vector & + const std::vector & n_locally_owned_dofs_per_processor () const; /** diff --git a/deal.II/include/deal.II/hp/dof_objects.h b/deal.II/include/deal.II/hp/dof_objects.h index cfcb837f60..145f394faa 100644 --- a/deal.II/include/deal.II/hp/dof_objects.h +++ b/deal.II/include/deal.II/hp/dof_objects.h @@ -210,7 +210,7 @@ namespace internal * on this object. */ template - unsigned int + types::global_dof_index nth_active_fe_index (const dealii::hp::DoFHandler &dof_handler, const unsigned int obj_level, const unsigned int obj_index, @@ -305,7 +305,7 @@ namespace internal // find a set for this // particular fe_index const types::global_dof_index starting_offset = dof_offsets[obj_index]; - const unsigned int *pointer = &dofs[starting_offset]; + const types::global_dof_index *pointer = &dofs[starting_offset]; while (true) { Assert (*pointer != numbers::invalid_unsigned_int, @@ -387,7 +387,7 @@ namespace internal // find a set for this // particular fe_index const types::global_dof_index starting_offset = dof_offsets[obj_index]; - unsigned int *pointer = &dofs[starting_offset]; + types::global_dof_index *pointer = &dofs[starting_offset]; while (true) { Assert (*pointer != numbers::invalid_unsigned_int, diff --git a/deal.II/include/deal.II/lac/compressed_sparsity_pattern.h b/deal.II/include/deal.II/lac/compressed_sparsity_pattern.h index 9ecc0ca4cc..37994cd9cf 100644 --- a/deal.II/include/deal.II/lac/compressed_sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/compressed_sparsity_pattern.h @@ -430,7 +430,7 @@ private: * the cache. This array is always * kept sorted. */ - mutable std::vector entries; + mutable std::vector entries; /** * Cache of entries that have not yet diff --git a/deal.II/include/deal.II/lac/sparse_direct.h b/deal.II/include/deal.II/lac/sparse_direct.h index 9c893d4638..5149d54f5a 100644 --- a/deal.II/include/deal.II/lac/sparse_direct.h +++ b/deal.II/include/deal.II/lac/sparse_direct.h @@ -978,15 +978,15 @@ private: * Call the ma47ad function * with the given args. */ - void call_ma47ad (const size_type *n_rows, - const size_type *n_nonzero_elements, - size_type *row_numbers, - size_type *column_numbers, - size_type *IW, - const size_type *LIW, - size_type *KEEP, - const size_type *ICNTL, - int *INFO); + void call_ma47ad (const size_type *n_rows, + const size_type *n_nonzero_elements, + size_type *row_numbers, + size_type *column_numbers, + size_type *IW, + const size_type *LIW, + size_type *KEEP, + const unsigned int *ICNTL, + int *INFO); /** * Call the ma47bd function diff --git a/deal.II/include/deal.II/lac/sparsity_pattern.h b/deal.II/include/deal.II/lac/sparsity_pattern.h index 00f7433ca2..61cae06570 100644 --- a/deal.II/include/deal.II/lac/sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/sparsity_pattern.h @@ -1801,7 +1801,7 @@ SparsityPattern::n_nonzero_elements () const template inline void -SparsityPattern::save (Archive &ar, const size_type) const +SparsityPattern::save (Archive &ar, const unsigned int) const { // forward to serialization function in the base class. ar &static_cast(*this); @@ -1817,7 +1817,7 @@ SparsityPattern::save (Archive &ar, const size_type) const template inline void -SparsityPattern::load (Archive &ar, const size_type) +SparsityPattern::load (Archive &ar, const unsigned int) { // forward to serialization function in the base class. ar &static_cast(*this); diff --git a/deal.II/include/deal.II/matrix_free/dof_info.h b/deal.II/include/deal.II/matrix_free/dof_info.h index 142268d83b..1c8f9f8539 100644 --- a/deal.II/include/deal.II/matrix_free/dof_info.h +++ b/deal.II/include/deal.II/matrix_free/dof_info.h @@ -154,7 +154,7 @@ namespace internal * assigned the correct index after all the ghost indices have been * collected by the call to @p assign_ghosts. */ - void read_dof_indices (const std::vector &local_indices, + void read_dof_indices (const std::vector &local_indices, const std::vector &lexicographic_inv, const ConstraintMatrix &constraints, const unsigned int cell_number, @@ -491,7 +491,7 @@ namespace internal inline - const unsigned int * + const types::global_dof_index * DoFInfo::begin_indices_plain (const unsigned int row) const { // if we have no constraints, should take the data from dof_indices @@ -513,7 +513,7 @@ namespace internal inline - const unsigned int * + const types::global_dof_index * DoFInfo::end_indices_plain (const unsigned int row) const { return begin_indices_plain(row) + diff --git a/deal.II/include/deal.II/matrix_free/dof_info.templates.h b/deal.II/include/deal.II/matrix_free/dof_info.templates.h index 9a28ef5686..bbc15a0e9a 100644 --- a/deal.II/include/deal.II/matrix_free/dof_info.templates.h +++ b/deal.II/include/deal.II/matrix_free/dof_info.templates.h @@ -1641,7 +1641,7 @@ not_connect: namespace internal { // rudimentary version of a vector that keeps entries always ordered - class ordered_vector : public std::vector + class ordered_vector : public std::vector { public: ordered_vector () @@ -1649,20 +1649,20 @@ not_connect: reserve (2000); } - void reserve (const unsigned int size) + void reserve (const types::global_dof_index size) { if (size > 0) - this->std::vector::reserve (size); + this->std::vector::reserve (size); } // insert a given entry. dat is a pointer within this vector (the user // needs to make sure that it really stays there) - void insert (const unsigned int entry, - std::vector::iterator &dat) + void insert (const types::global_dof_index entry, + std::vector::iterator &dat) { - AssertIndexRange (static_cast(dat - begin()), size()+1); - AssertIndexRange (static_cast(end() - dat), size()+1); + AssertIndexRange (static_cast(dat - begin()), size()+1); + AssertIndexRange (static_cast(end() - dat), size()+1); AssertIndexRange (size(), capacity()); while (dat != end() && *dat < entry) ++dat; @@ -1674,7 +1674,7 @@ not_connect: } else if (*dat > entry) { - dat = this->std::vector::insert (dat, entry); + dat = this->std::vector::insert (dat, entry); ++dat; } else @@ -1694,17 +1694,18 @@ not_connect: CompressedSimpleSparsityPattern &connectivity) const { AssertDimension (row_starts.size()-1, size_info.n_active_cells); - const unsigned int n_rows = (vector_partitioner->local_range().second- + const types::global_dof_index n_rows = + (vector_partitioner->local_range().second- vector_partitioner->local_range().first) + vector_partitioner->ghost_indices().n_elements(); - const unsigned int n_blocks = (do_blocking == true) ? + const types::global_dof_index n_blocks = (do_blocking == true) ? task_info.n_blocks : size_info.n_active_cells; // first determine row lengths - std::vector row_lengths(n_rows); + std::vector row_lengths(n_rows); unsigned int cell_start = 0, mcell_start = 0; std::vector scratch; - for (unsigned int block = 0; block < n_blocks; ++block) + for (types::global_dof_index block = 0; block < n_blocks; ++block) { // if we have the blocking variant (used in the coloring scheme), we // want to build a graph with the blocks with interaction with @@ -1748,7 +1749,7 @@ not_connect: } // disregard dofs that only sit on one cell - for (unsigned int row=0; row & + const std::vector & get_constrained_dofs (const unsigned int fe_component = 0) const; /** * Calls renumber_dofs function in dof info which renumbers the degrees * of freedom according to the ordering for parallelization. */ - void renumber_dofs (std::vector &renumbering, + void renumber_dofs (std::vector &renumbering, const unsigned int vector_component = 0); //@} @@ -970,7 +970,7 @@ MatrixFree::get_vector_partitioner (const unsigned int comp) const template inline -const std::vector & +const std::vector & MatrixFree::get_constrained_dofs (const unsigned int comp) const { AssertIndexRange (comp, n_components()); @@ -1157,7 +1157,7 @@ MatrixFree::create_cell_subrange_hp_by_index template inline void -MatrixFree::renumber_dofs (std::vector &renumbering, +MatrixFree::renumber_dofs (std::vector &renumbering, const unsigned int vector_component) { AssertIndexRange(vector_component, dof_info.size()); diff --git a/deal.II/include/deal.II/matrix_free/matrix_free.templates.h b/deal.II/include/deal.II/matrix_free/matrix_free.templates.h index ba556a02e9..3c38036ffa 100644 --- a/deal.II/include/deal.II/matrix_free/matrix_free.templates.h +++ b/deal.II/include/deal.II/matrix_free/matrix_free.templates.h @@ -411,7 +411,7 @@ void MatrixFree::initialize_indices AssertDimension (n_fe, locally_owned_set.size()); AssertDimension (n_fe, constraint.size()); - std::vector local_dof_indices; + std::vector local_dof_indices; std::vector > ghost_dofs(n_fe); std::vector > > lexicographic_inv(n_fe); @@ -684,7 +684,7 @@ void MatrixFree::initialize_indices } // set constraint pool from the std::map and reorder the indices - typename std::map, unsigned int, + typename std::map, types::global_dof_index, internal::MatrixFreeFunctions::FPArrayComparator >::iterator it = constraint_values.constraints.begin(), end = constraint_values.constraints.end(); diff --git a/deal.II/include/deal.II/meshworker/dof_info.h b/deal.II/include/deal.II/meshworker/dof_info.h index ecce7cb5bf..e1be3f30b2 100644 --- a/deal.II/include/deal.II/meshworker/dof_info.h +++ b/deal.II/include/deal.II/meshworker/dof_info.h @@ -298,7 +298,7 @@ namespace MeshWorker template DoFInfo::DoFInfo(const DH &dof_handler) { - std::vector aux(1); + std::vector aux(1); aux[0] = dof_handler.get_fe().dofs_per_cell; aux_local_indices.reinit(aux); } diff --git a/deal.II/include/deal.II/meshworker/vector_selector.h b/deal.II/include/deal.II/meshworker/vector_selector.h index 0edf1df4f6..80f32264c9 100644 --- a/deal.II/include/deal.II/meshworker/vector_selector.h +++ b/deal.II/include/deal.II/meshworker/vector_selector.h @@ -290,7 +290,7 @@ namespace MeshWorker std::vector > > > &gradients, std::vector > > > &hessians, const FEValuesBase &fe, - const std::vector &index, + const std::vector &index, const unsigned int component, const unsigned int n_comp, const unsigned int start, @@ -313,7 +313,7 @@ namespace MeshWorker std::vector > > > &hessians, const FEValuesBase &fe, const unsigned int level, - const std::vector &index, + const std::vector &index, const unsigned int component, const unsigned int n_comp, const unsigned int start, @@ -382,7 +382,7 @@ namespace MeshWorker std::vector > > > &gradients, std::vector > > > &hessians, const FEValuesBase &fe, - const std::vector &index, + const std::vector &index, const unsigned int component, const unsigned int n_comp, const unsigned int start, @@ -455,7 +455,7 @@ namespace MeshWorker std::vector > > > &hessians, const FEValuesBase &fe, const unsigned int level, - const std::vector &index, + const std::vector &index, const unsigned int component, const unsigned int n_comp, const unsigned int start, diff --git a/deal.II/include/deal.II/meshworker/vector_selector.templates.h b/deal.II/include/deal.II/meshworker/vector_selector.templates.h index 36a2dbb1ee..1490db53bc 100644 --- a/deal.II/include/deal.II/meshworker/vector_selector.templates.h +++ b/deal.II/include/deal.II/meshworker/vector_selector.templates.h @@ -42,7 +42,7 @@ namespace MeshWorker std::vector > > > &, std::vector > > > &, const FEValuesBase &, - const std::vector &, + const std::vector &, const unsigned int, const unsigned int, const unsigned int, @@ -60,7 +60,7 @@ namespace MeshWorker std::vector > > > &, const FEValuesBase &, const unsigned int, - const std::vector &, + const std::vector &, const unsigned int, const unsigned int, const unsigned int, @@ -110,7 +110,7 @@ namespace MeshWorker std::vector > > > &gradients, std::vector > > > &hessians, const FEValuesBase &fe, - const std::vector &index, + const std::vector &index, const unsigned int component, const unsigned int n_comp, const unsigned int start, @@ -194,7 +194,7 @@ namespace MeshWorker std::vector > > > &hessians, const FEValuesBase &fe, const unsigned int level, - const std::vector &index, + const std::vector &index, const unsigned int component, const unsigned int n_comp, const unsigned int start, diff --git a/deal.II/include/deal.II/numerics/solution_transfer.h b/deal.II/include/deal.II/numerics/solution_transfer.h index 74614686a0..e42b9261f8 100644 --- a/deal.II/include/deal.II/numerics/solution_transfer.h +++ b/deal.II/include/deal.II/numerics/solution_transfer.h @@ -432,7 +432,7 @@ private: struct Pointerstruct { Pointerstruct() : indices_ptr(0), dof_values_ptr(0), active_fe_index(0) {}; - Pointerstruct(std::vector *indices_ptr_in, + Pointerstruct(std::vector *indices_ptr_in, const unsigned int active_fe_index_in = 0) : indices_ptr(indices_ptr_in), @@ -445,7 +445,7 @@ private: active_fe_index(active_fe_index_in) {}; std::size_t memory_consumption () const; - std::vector *indices_ptr; + std::vector *indices_ptr; std::vector > *dof_values_ptr; unsigned int active_fe_index; }; diff --git a/deal.II/include/deal.II/numerics/vector_tools.templates.h b/deal.II/include/deal.II/numerics/vector_tools.templates.h index 346401eb9d..8081e8f2ae 100644 --- a/deal.II/include/deal.II/numerics/vector_tools.templates.h +++ b/deal.II/include/deal.II/numerics/vector_tools.templates.h @@ -3366,7 +3366,7 @@ namespace VectorTools std::vector dofs_processed (dofs_per_face); std::vector dof_values (dofs_per_face); - std::vector face_dof_indices (dofs_per_face); + std::vector face_dof_indices (dofs_per_face); typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active (); switch (dim) @@ -3943,7 +3943,7 @@ namespace VectorTools const Function &, const std::vector > &, std::vector &, - std::vector &) + std::vector &) { Assert (false, ExcNotImplemented ()); } diff --git a/deal.II/source/dofs/block_info.cc b/deal.II/source/dofs/block_info.cc index a81c86c252..9e7dd902f8 100644 --- a/deal.II/source/dofs/block_info.cc +++ b/deal.II/source/dofs/block_info.cc @@ -30,14 +30,14 @@ BlockInfo::initialize(const DoFHandler &dof, bool levels_only, bo if (!levels_only && dof.has_active_dofs()) { const FiniteElement &fe = dof.get_fe(); - std::vector sizes(fe.n_blocks()); + std::vector sizes(fe.n_blocks()); DoFTools::count_dofs_per_block(dof, sizes); bi_global.reinit(sizes); } if (!active_only && dof.has_level_dofs()) { - std::vector > sizes (dof.get_tria ().n_levels ()); + std::vector > sizes (dof.get_tria ().n_levels ()); for (unsigned int i = 0; i < sizes.size (); ++i) sizes[i].resize (dof.get_fe ().n_blocks ()); @@ -56,7 +56,7 @@ void BlockInfo::initialize_local(const DoFHandler &dof) { const FiniteElement &fe = dof.get_fe(); - std::vector sizes(fe.n_blocks()); + std::vector sizes(fe.n_blocks()); base_elements.resize(fe.n_blocks()); diff --git a/deal.II/source/dofs/dof_handler.cc b/deal.II/source/dofs/dof_handler.cc index dffe4724f5..763fd9758c 100644 --- a/deal.II/source/dofs/dof_handler.cc +++ b/deal.II/source/dofs/dof_handler.cc @@ -120,7 +120,7 @@ namespace internal // nodes) // count lines -> 28 (don't forget to count // mother and children separately!) - unsigned int max_couplings; + types::global_dof_index max_couplings; switch (dof_handler.tria->max_adjacent_cells()) { case 4: @@ -223,7 +223,7 @@ namespace internal const unsigned int max_adjacent_cells = dof_handler.tria->max_adjacent_cells(); - unsigned int max_couplings; + types::global_dof_index max_couplings; if (max_adjacent_cells <= 8) max_couplings=7*7*7*dof_handler.selected_fe->dofs_per_vertex + 7*6*7*3*dof_handler.selected_fe->dofs_per_line + @@ -364,7 +364,7 @@ namespace internal for (unsigned int i = 0; i < n_levels; ++i) { dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<1>); - dof_handler.mg_levels.back ()->dof_object.dofs = std::vector (tria.n_raw_lines (i) * dofs_per_line, DoFHandler<1>::invalid_dof_index); + dof_handler.mg_levels.back ()->dof_object.dofs = std::vector (tria.n_raw_lines (i) * dofs_per_line, DoFHandler<1>::invalid_dof_index); } const unsigned int &n_vertices = tria.n_vertices (); @@ -420,11 +420,11 @@ namespace internal for (unsigned int i = 0; i < n_levels; ++i) { dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<2>); - dof_handler.mg_levels.back ()->dof_object.dofs = std::vector (tria.n_raw_quads (i) * fe.dofs_per_quad, DoFHandler<2>::invalid_dof_index); + dof_handler.mg_levels.back ()->dof_object.dofs = std::vector (tria.n_raw_quads (i) * fe.dofs_per_quad, DoFHandler<2>::invalid_dof_index); } dof_handler.mg_faces = new internal::DoFHandler::DoFFaces<2>; - dof_handler.mg_faces->lines.dofs = std::vector (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<2>::invalid_dof_index); + dof_handler.mg_faces->lines.dofs = std::vector (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<2>::invalid_dof_index); const unsigned int &n_vertices = tria.n_vertices (); @@ -479,12 +479,12 @@ namespace internal for (unsigned int i = 0; i < n_levels; ++i) { dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<3>); - dof_handler.mg_levels.back ()->dof_object.dofs = std::vector (tria.n_raw_hexs (i) * fe.dofs_per_hex, DoFHandler<3>::invalid_dof_index); + dof_handler.mg_levels.back ()->dof_object.dofs = std::vector (tria.n_raw_hexs (i) * fe.dofs_per_hex, DoFHandler<3>::invalid_dof_index); } dof_handler.mg_faces = new internal::DoFHandler::DoFFaces<3>; - dof_handler.mg_faces->lines.dofs = std::vector (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<3>::invalid_dof_index); - dof_handler.mg_faces->quads.dofs = std::vector (tria.n_raw_quads () * fe.dofs_per_quad, DoFHandler<3>::invalid_dof_index); + dof_handler.mg_faces->lines.dofs = std::vector (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<3>::invalid_dof_index); + dof_handler.mg_faces->quads.dofs = std::vector (tria.n_raw_quads () * fe.dofs_per_quad, DoFHandler<3>::invalid_dof_index); const unsigned int &n_vertices = tria.n_vertices (); @@ -1283,7 +1283,7 @@ void DoFHandler<1>::renumber_dofs (const unsigned int level, for (unsigned int d=0; dget_fe().dofs_per_vertex; ++d) i->set_index (level, d, new_numbers[i->get_index (level, d)]); - for (std::vector::iterator i=mg_levels[level]->dof_object.dofs.begin(); + for (std::vector::iterator i=mg_levels[level]->dof_object.dofs.begin(); i!=mg_levels[level]->dof_object.dofs.end(); ++i) { if (*i != DoFHandler<1>::invalid_dof_index) @@ -1342,7 +1342,7 @@ void DoFHandler<2>::renumber_dofs (const unsigned int level, const_cast &>(this->get_tria()).load_user_flags (user_flags); } - for (std::vector::iterator i=mg_levels[level]->dof_object.dofs.begin(); + for (std::vector::iterator i=mg_levels[level]->dof_object.dofs.begin(); i!=mg_levels[level]->dof_object.dofs.end(); ++i) { if (*i != DoFHandler<2>::invalid_dof_index) @@ -1436,7 +1436,7 @@ void DoFHandler<3>::renumber_dofs (const unsigned int level, } //HEX DoFs - for (std::vector::iterator i=mg_levels[level]->dof_object.dofs.begin(); + for (std::vector::iterator i=mg_levels[level]->dof_object.dofs.begin(); i!=mg_levels[level]->dof_object.dofs.end(); ++i) { if (*i != DoFHandler<3>::invalid_dof_index) @@ -1574,13 +1574,13 @@ void DoFHandler::MGVertexDoFs::init (const unsigned int cl, const const unsigned int n_levels = finest_level - coarsest_level + 1; const unsigned int n_indices = n_levels * dofs_per_vertex; - indices = new unsigned int[n_indices]; + indices = new types::global_dof_index[n_indices]; Assert (indices != 0, ExcNoMemory ()); for (unsigned int i = 0; i < n_indices; ++i) indices[i] = DoFHandler::invalid_dof_index; - indices_offset = new unsigned int[n_levels]; + indices_offset = new types::global_dof_index[n_levels]; Assert (indices != 0, ExcNoMemory ()); for (unsigned int i = 0; i < n_levels; ++i) diff --git a/deal.II/source/dofs/dof_handler.inst.in b/deal.II/source/dofs/dof_handler.inst.in index 80634abba3..9f9ccbf7ba 100644 --- a/deal.II/source/dofs/dof_handler.inst.in +++ b/deal.II/source/dofs/dof_handler.inst.in @@ -33,7 +33,7 @@ for (deal_II_dimension : DIMENSIONS) template class DoFHandler<1,deal_II_dimension>; template - unsigned int + types::global_dof_index DoFHandler<1,3>:: get_dof_index<1> (const unsigned int obj_level, const unsigned int obj_index, @@ -42,7 +42,7 @@ for (deal_II_dimension : DIMENSIONS) #endif template -unsigned int +types::global_dof_index DoFHandler:: get_dof_index<1> (const unsigned int obj_level, const unsigned int obj_index, @@ -51,7 +51,7 @@ get_dof_index<1> (const unsigned int obj_level, #if deal_II_dimension < 3 template -unsigned int +types::global_dof_index DoFHandler:: get_dof_index<1> (const unsigned int obj_level, const unsigned int obj_index, @@ -61,7 +61,7 @@ get_dof_index<1> (const unsigned int obj_level, #if deal_II_dimension >= 2 template -unsigned int +types::global_dof_index DoFHandler:: get_dof_index<2> (const unsigned int obj_level, const unsigned int obj_index, @@ -70,7 +70,7 @@ get_dof_index<2> (const unsigned int obj_level, #if deal_II_dimension < 3 template -unsigned int +types::global_dof_index DoFHandler:: get_dof_index<2> (const unsigned int obj_level, const unsigned int obj_index, @@ -80,7 +80,7 @@ get_dof_index<2> (const unsigned int obj_level, #if deal_II_dimension >= 3 template -unsigned int +types::global_dof_index DoFHandler:: get_dof_index<3> (const unsigned int obj_level, const unsigned int obj_index, @@ -93,20 +93,20 @@ template void DoFHandler:: set_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const unsigned int global_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #if deal_II_dimension < 3 template void DoFHandler:: set_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const unsigned int global_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #endif #if deal_II_dimension < 2 @@ -114,10 +114,10 @@ template void DoFHandler:: set_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const unsigned int global_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #endif #if deal_II_dimension >= 2 @@ -125,20 +125,20 @@ template void DoFHandler:: set_dof_index<2> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const unsigned int global_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #if deal_II_dimension < 3 template void DoFHandler:: set_dof_index<2> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const unsigned int global_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #endif #if deal_II_dimension >= 3 @@ -146,10 +146,10 @@ template void DoFHandler:: set_dof_index<3> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const unsigned int global_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #endif #endif } diff --git a/deal.II/source/dofs/dof_objects.inst.in b/deal.II/source/dofs/dof_objects.inst.in index 9335c160ad..08e28bcc33 100644 --- a/deal.II/source/dofs/dof_objects.inst.in +++ b/deal.II/source/dofs/dof_objects.inst.in @@ -54,14 +54,14 @@ for (deal_II_dimension, structdim : DIMENSIONS) const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, - const unsigned int global_index); + const types::global_dof_index global_index); #endif #if (deal_II_dimension == 3) && (structdim < 3) template - unsigned int + types::global_dof_index DoFObjects:: get_dof_index (const dealii::DoFHandler<1,3> &dof_handler, const unsigned int obj_index, diff --git a/deal.II/source/dofs/dof_tools.cc b/deal.II/source/dofs/dof_tools.cc index e0a5e64a34..bdcccec352 100644 --- a/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/source/dofs/dof_tools.cc @@ -5131,8 +5131,8 @@ namespace DoFTools // innocent block of code. basically, it must be the // ConstraintMatrix::add_entry call which takes the bulk of the time, // but it is not known to the author how to make it faster... - std::vector > constraint_line; - for (unsigned int global_dof=0; global_dof > constraint_line; + for (types::global_dof_index global_dof=0; global_dof::const_iterator j = weights[row].find(col); if ((j != weights[row].end()) && (j->second != 0)) - constraint_line.push_back (std::pair(representants[row], - j->second)); + constraint_line.push_back (std::pair(representants[row], + j->second)); }; constraints.add_entries (global_dof, constraint_line); diff --git a/deal.II/source/fe/fe_values.inst.in b/deal.II/source/fe/fe_values.inst.in index 111b81394a..fb01f675dc 100644 --- a/deal.II/source/fe/fe_values.inst.in +++ b/deal.II/source/fe/fe_values.inst.in @@ -136,10 +136,10 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi (const VEC&, std::vector&) const; template void FEValuesBase::get_function_values - (const VEC&, const VectorSlice >&, std::vector&) const; + (const VEC&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_values - (const VEC&, const VectorSlice >&, std::vector&) const; + (const VEC&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_values @@ -150,20 +150,20 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi template void FEValuesBase::get_function_values - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_values - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_values - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, VectorSlice > >, bool) const; // template // void FEValuesBase::get_function_values -// (const VEC&, const VectorSlice >&, +// (const VEC&, const VectorSlice >&, // VectorSlice > >, bool) const; template @@ -171,7 +171,7 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi (const VEC&, std::vector > &) const; template void FEValuesBase::get_function_gradients - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, std::vector > &) const; template @@ -179,7 +179,7 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi (const VEC&, std::vector > > &) const; template void FEValuesBase::get_function_gradients - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, VectorSlice > > >, bool) const; template @@ -187,7 +187,7 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi (const VEC&, std::vector > &) const; template void FEValuesBase::get_function_hessians - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, std::vector > &) const; template @@ -195,7 +195,7 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi (const VEC&, std::vector > > &, bool) const; template void FEValuesBase::get_function_hessians - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, VectorSlice > > >, bool) const; template @@ -206,10 +206,10 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi (const VEC&, std::vector&) const; template void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, std::vector&) const; + (const VEC&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, std::vector&) const; + (const VEC&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_laplacians @@ -220,20 +220,20 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimensi template void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, std::vector > &, bool) const; template void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, + (const VEC&, const VectorSlice >&, std::vector > &, bool) const; #endif @@ -360,10 +360,10 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector&) const; template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, std::vector&) const; + (const IndexSet&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, std::vector&) const; + (const IndexSet&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_values @@ -374,20 +374,20 @@ for (deal_II_dimension : DIMENSIONS) template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, VectorSlice > >, bool) const; // template // void FEValuesBase::get_function_values -// (const IndexSet&, const VectorSlice >&, +// (const IndexSet&, const VectorSlice >&, // VectorSlice > >, bool) const; template @@ -395,7 +395,7 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector > &) const; template void FEValuesBase::get_function_gradients - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template @@ -403,7 +403,7 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector > > &) const; template void FEValuesBase::get_function_gradients - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, VectorSlice > > >, bool) const; template @@ -411,7 +411,7 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector > &) const; template void FEValuesBase::get_function_hessians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template @@ -419,7 +419,7 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector > > &, bool) const; template void FEValuesBase::get_function_hessians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, VectorSlice > > >, bool) const; template @@ -430,10 +430,10 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector&) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, std::vector&) const; + (const IndexSet&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, std::vector&) const; + (const IndexSet&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_laplacians @@ -444,20 +444,20 @@ for (deal_II_dimension : DIMENSIONS) template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &, bool) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &, bool) const; @@ -471,10 +471,10 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector&) const; template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, std::vector&) const; + (const IndexSet&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, std::vector&) const; + (const IndexSet&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_values @@ -485,20 +485,20 @@ for (deal_II_dimension : DIMENSIONS) template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, VectorSlice > >, bool) const; // template // void FEValuesBase::get_function_values -// (const IndexSet&, const VectorSlice >&, +// (const IndexSet&, const VectorSlice >&, // VectorSlice > >, bool) const; template @@ -506,7 +506,7 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector > &) const; template void FEValuesBase::get_function_gradients - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template @@ -514,7 +514,7 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector > > &) const; template void FEValuesBase::get_function_gradients - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, VectorSlice > > >, bool) const; template @@ -522,7 +522,7 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector > &) const; template void FEValuesBase::get_function_hessians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template @@ -530,7 +530,7 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector > > &, bool) const; template void FEValuesBase::get_function_hessians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, VectorSlice > > >, bool) const; template @@ -541,10 +541,10 @@ for (deal_II_dimension : DIMENSIONS) (const IndexSet&, std::vector&) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, std::vector&) const; + (const IndexSet&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, std::vector&) const; + (const IndexSet&, const VectorSlice >&, std::vector&) const; template void FEValuesBase::get_function_laplacians @@ -555,20 +555,20 @@ for (deal_II_dimension : DIMENSIONS) template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &, bool) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, + (const IndexSet&, const VectorSlice >&, std::vector > &, bool) const; #endif diff --git a/deal.II/source/lac/chunk_sparse_matrix.inst.in b/deal.II/source/lac/chunk_sparse_matrix.inst.in index 3b1b4e6a74..d8a46dcf3f 100644 --- a/deal.II/source/lac/chunk_sparse_matrix.inst.in +++ b/deal.II/source/lac/chunk_sparse_matrix.inst.in @@ -81,13 +81,13 @@ for (S1, S2 : REAL_SCALARS) const S1) const; template void ChunkSparseMatrix:: PSOR (Vector &, - const std::vector&, - const std::vector&, + const std::vector&, + const std::vector&, const S1) const; template void ChunkSparseMatrix:: TPSOR (Vector &, - const std::vector&, - const std::vector&, + const std::vector&, + const std::vector&, const S1) const; template void ChunkSparseMatrix:: SOR_step (Vector &, @@ -188,13 +188,13 @@ for (S1, S2, S3 : REAL_SCALARS; // const S1) const; // template void ChunkSparseMatrix:: // PSOR (Vector &, -// const std::vector&, -// const std::vector&, +// const std::vector&, +// const std::vector&, // const S1) const; // template void ChunkSparseMatrix:: // TPSOR (Vector &, -// const std::vector&, -// const std::vector&, +// const std::vector&, +// const std::vector&, // const S1) const; // template void ChunkSparseMatrix:: // SOR_step (Vector &, diff --git a/deal.II/source/lac/compressed_sparsity_pattern.cc b/deal.II/source/lac/compressed_sparsity_pattern.cc index 273f3bf726..f589438965 100644 --- a/deal.II/source/lac/compressed_sparsity_pattern.cc +++ b/deal.II/source/lac/compressed_sparsity_pattern.cc @@ -151,7 +151,7 @@ CompressedSparsityPattern::Line::flush_cache () const ExcInternalError()); if (n_new_entries > entries.size()) { - std::vector new_entries; + std::vector new_entries; new_entries.reserve (n_new_entries); unsigned int cache_position = 0; unsigned int entry_position = 0; @@ -265,7 +265,7 @@ CompressedSparsityPattern::Line::add_entries (ForwardIterator begin, ExcInternalError()); if (n_new_entries > entries.size()) { - std::vector new_entries; + std::vector new_entries; new_entries.reserve (n_new_entries); ForwardIterator my_it = begin; unsigned int entry_position = 0; diff --git a/deal.II/source/lac/constraint_matrix.inst.pl b/deal.II/source/lac/constraint_matrix.inst.pl index 7e47773f01..b4cc95432b 100644 --- a/deal.II/source/lac/constraint_matrix.inst.pl +++ b/deal.II/source/lac/constraint_matrix.inst.pl @@ -20,7 +20,7 @@ my $vector_functions = <<'EOT' template void ConstraintMatrix::condense(const V1 &, V1&) const; template void ConstraintMatrix::condense(V1 &vec) const; template void ConstraintMatrix::distribute_local_to_global ( - const Vector&, const std::vector &, V1&, const FullMatrix&) const; + const Vector&, const std::vector &, V1&, const FullMatrix&) const; template void ConstraintMatrix::distribute(const V1 &, V1&) const; template void ConstraintMatrix::distribute(V1 &) const; EOT diff --git a/deal.II/source/lac/full_matrix.inst.in b/deal.II/source/lac/full_matrix.inst.in index 47db43ec24..0a08486187 100644 --- a/deal.II/source/lac/full_matrix.inst.in +++ b/deal.II/source/lac/full_matrix.inst.in @@ -22,22 +22,22 @@ for (S : REAL_SCALARS) std::ostream&, const unsigned int, const unsigned int) const; template void FullMatrix::copy_from<1>( - const Tensor<2,1>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned); + const Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); template void FullMatrix::copy_from<2>( - const Tensor<2,2>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned); + const Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); template void FullMatrix::copy_from<3>( - const Tensor<2,3>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned); + const Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); template void FullMatrix::copy_to<1>( - Tensor<2,1>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const; + Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; template void FullMatrix::copy_to<2>( - Tensor<2,2>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const; + Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; template void FullMatrix::copy_to<3>( - Tensor<2,3>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const; + Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; } for (S1, S2 : REAL_SCALARS) diff --git a/deal.II/source/lac/sparse_direct.cc b/deal.II/source/lac/sparse_direct.cc index c585b15296..d150412cd1 100644 --- a/deal.II/source/lac/sparse_direct.cc +++ b/deal.II/source/lac/sparse_direct.cc @@ -1409,8 +1409,8 @@ SparseDirectMA47::fill_A (const SparseMatrix &matrix) void -SparseDirectMA47::call_ma47id (double *CNTL, // length 2 - unsigned int *ICNTL) // length 7 +SparseDirectMA47::call_ma47id (double *CNTL, // length 2 + size_type *ICNTL) // length 7 { HSL::MA47::ma47id_ (CNTL, ICNTL); } diff --git a/deal.II/source/numerics/matrix_tools.inst.in b/deal.II/source/numerics/matrix_tools.inst.in index ad686e7118..26432a78a2 100644 --- a/deal.II/source/numerics/matrix_tools.inst.in +++ b/deal.II/source/numerics/matrix_tools.inst.in @@ -85,7 +85,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS SparseMatrix &matrix, const FunctionMap::type &rhs, Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, + std::vector &dof_to_boundary_mapping, const Function * const a, std::vector); @@ -97,7 +97,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS SparseMatrix &matrix, const FunctionMap::type &rhs, Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, + std::vector &dof_to_boundary_mapping, const Function * const a, std::vector); @@ -192,7 +192,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS SparseMatrix&, const FunctionMap::type&, Vector&, - std::vector&, + std::vector&, const Function * const, std::vector); @@ -203,7 +203,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS SparseMatrix&, const FunctionMap::type&, Vector&, - std::vector&, + std::vector&, const Function * const, std::vector); diff --git a/deal.II/source/numerics/solution_transfer.cc b/deal.II/source/numerics/solution_transfer.cc index 14aed16b67..c2d78805f1 100644 --- a/deal.II/source/numerics/solution_transfer.cc +++ b/deal.II/source/numerics/solution_transfer.cc @@ -76,7 +76,7 @@ void SolutionTransfer::prepare_for_pure_refinement() n_dofs_old=dof_handler->n_dofs(); // efficient reallocation of indices_on_cell - std::vector > (n_active_cells) + std::vector > (n_active_cells) .swap(indices_on_cell); typename DH::active_cell_iterator cell = dof_handler->begin_active(), @@ -291,7 +291,7 @@ prepare_for_coarsening_and_refinement(const std::vector &all_in) // allocate the needed memory. initialize // the following arrays in an efficient // way, without copying much - std::vector > + std::vector > (n_cells_to_stay_or_refine) .swap(indices_on_cell); @@ -516,7 +516,7 @@ interpolate (const std::vector &all_in, if (pointerstruct!=cell_map_end) { - const std::vector *const indexptr + const std::vector *const indexptr =pointerstruct->second.indices_ptr; const std::vector > *const valuesptr diff --git a/deal.II/source/numerics/vector_tools.inst.in b/deal.II/source/numerics/vector_tools.inst.in index eedd5c9de3..91061586fb 100644 --- a/deal.II/source/numerics/vector_tools.inst.in +++ b/deal.II/source/numerics/vector_tools.inst.in @@ -284,7 +284,7 @@ for (deal_II_dimension : DIMENSIONS) const MGDoFHandler &, const types::boundary_id, const Function &, - std::map &, + std::map &, const ComponentMask &); \} } @@ -299,7 +299,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; (const Mapping &, const DH &, const FunctionMap::type &, - std::map &, + std::map &, const ComponentMask &); template @@ -308,7 +308,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; const DH &, const types::boundary_id, const Function &, - std::map &, + std::map &, const ComponentMask &); template @@ -316,14 +316,14 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; const DH &, const types::boundary_id, const Function &, - std::map &, + std::map &, const ComponentMask &); template void interpolate_boundary_values (const DH &, const FunctionMap::type &, - std::map &, + std::map &, const ComponentMask &); template @@ -511,7 +511,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS const DoFHandler &, const FunctionMap::type &, const Quadrature&, - std::map&, std::vector); + std::map&, std::vector); #endif template @@ -519,7 +519,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS (const DoFHandler &, const FunctionMap::type &, const Quadrature&, - std::map&, std::vector); + std::map&, std::vector); template