From 76ddfe256c86dd9771a4a7e33b7a99d8c947440b Mon Sep 17 00:00:00 2001 From: turcksin Date: Tue, 5 Mar 2013 15:12:51 +0000 Subject: [PATCH] Convert unsigned int to types::global_dof_index. The first step of the tutorial compiles and runs. git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28737 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/include/deal.II/dofs/block_info.h | 6 +++--- deal.II/include/deal.II/dofs/dof_renumbering.h | 2 +- deal.II/include/deal.II/fe/fe_tools.h | 2 +- deal.II/source/dofs/dof_renumbering.cc | 4 ++-- deal.II/source/dofs/dof_tools.cc | 4 ++-- deal.II/source/dofs/dof_tools.inst.in | 18 +++++++++--------- deal.II/source/fe/fe_tools.cc | 6 +++--- deal.II/source/fe/fe_tools.inst.in | 2 +- deal.II/source/multigrid/mg_tools.cc | 2 +- deal.II/source/multigrid/mg_tools.inst.in | 4 ++-- 10 files changed, 25 insertions(+), 25 deletions(-) diff --git a/deal.II/include/deal.II/dofs/block_info.h b/deal.II/include/deal.II/dofs/block_info.h index 835d5270e5..b428e19ee2 100644 --- a/deal.II/include/deal.II/dofs/block_info.h +++ b/deal.II/include/deal.II/dofs/block_info.h @@ -158,7 +158,7 @@ public: * in the standard local * numbering of DoFAccessor. */ - unsigned int renumber (const unsigned int i) const; + types::global_dof_index renumber (const types::global_dof_index i) const; /** * The number of base elements. @@ -226,7 +226,7 @@ private: * ordering. Filled by * initialize(). */ - std::vector local_renumbering; + std::vector local_renumbering; }; @@ -259,7 +259,7 @@ BlockInfo::level (const unsigned int l) const inline -unsigned int BlockInfo::renumber (const unsigned int i) const +types::global_dof_index BlockInfo::renumber (const types::global_dof_index i) const { AssertIndexRange(i, local_renumbering.size()); return local_renumbering[i]; diff --git a/deal.II/include/deal.II/dofs/dof_renumbering.h b/deal.II/include/deal.II/dofs/dof_renumbering.h index f14d277bb2..fc608becb2 100644 --- a/deal.II/include/deal.II/dofs/dof_renumbering.h +++ b/deal.II/include/deal.II/dofs/dof_renumbering.h @@ -919,7 +919,7 @@ namespace DoFRenumbering * the renumbering vector. */ template - unsigned int + types::global_dof_index compute_block_wise (std::vector &new_dof_indices, const ITERATOR &start, const ENDITERATOR &end); diff --git a/deal.II/include/deal.II/fe/fe_tools.h b/deal.II/include/deal.II/fe/fe_tools.h index 99b0671052..364d83b55f 100644 --- a/deal.II/include/deal.II/fe/fe_tools.h +++ b/deal.II/include/deal.II/fe/fe_tools.h @@ -169,7 +169,7 @@ namespace FETools template void compute_block_renumbering ( const FiniteElement &fe, - std::vector &renumbering, + std::vector &renumbering, std::vector &block_data, bool return_start_indices = true); diff --git a/deal.II/source/dofs/dof_renumbering.cc b/deal.II/source/dofs/dof_renumbering.cc index e0c3402c8e..618c6cbdfd 100644 --- a/deal.II/source/dofs/dof_renumbering.cc +++ b/deal.II/source/dofs/dof_renumbering.cc @@ -1070,13 +1070,13 @@ namespace DoFRenumbering types::global_dof_index next_free_index = 0; for (unsigned int block=0; block::const_iterator + const typename std::vector::const_iterator begin_of_component = block_to_dof_map[block].begin(), end_of_component = block_to_dof_map[block].end(); next_free_index = shifts[block]; - for (typename std::vector::const_iterator + for (typename std::vector::const_iterator dof_index = begin_of_component; dof_index != end_of_component; ++dof_index) { diff --git a/deal.II/source/dofs/dof_tools.cc b/deal.II/source/dofs/dof_tools.cc index fbbfc216fb..ae3fb7e44c 100644 --- a/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/source/dofs/dof_tools.cc @@ -4521,9 +4521,9 @@ namespace DoFTools void count_dofs_per_block (const DH &dof_handler, std::vector &dofs_per_block, - const std::vector &target_block_) + const std::vector &target_block_) { - std::vector target_block = target_block_; + std::vector target_block = target_block_; const dealii::hp::FECollection fe_collection (dof_handler.get_fe()); diff --git a/deal.II/source/dofs/dof_tools.inst.in b/deal.II/source/dofs/dof_tools.inst.in index d2c6af3fb3..124592fb4f 100644 --- a/deal.II/source/dofs/dof_tools.inst.in +++ b/deal.II/source/dofs/dof_tools.inst.in @@ -877,21 +877,21 @@ void DoFTools::count_dofs_per_block > ( const DoFHandler&, std::vector&, - const std::vector &); + const std::vector &); template void DoFTools::count_dofs_per_block > ( const hp::DoFHandler&, std::vector&, - const std::vector &); + const std::vector &); template void DoFTools::count_dofs_per_block > ( const MGDoFHandler&, std::vector&, - const std::vector &); + const std::vector &); template void @@ -1013,21 +1013,21 @@ void DoFTools::count_dofs_per_block > ( const DoFHandler&, std::vector&, - const std::vector &); + const std::vector &); template void DoFTools::count_dofs_per_block > ( const hp::DoFHandler&, std::vector&, - const std::vector &); + const std::vector &); template void DoFTools::count_dofs_per_block > ( const MGDoFHandler&, std::vector&, - const std::vector &); + const std::vector &); #endif @@ -1046,21 +1046,21 @@ void DoFTools::count_dofs_per_block > ( const DoFHandler<1,3>&, std::vector&, - const std::vector &); + const std::vector &); template void DoFTools::count_dofs_per_block > ( const hp::DoFHandler<1,3>&, std::vector&, - const std::vector &); + const std::vector &); template void DoFTools::count_dofs_per_block > ( const MGDoFHandler<1,3>&, std::vector&, - const std::vector &); + const std::vector &); #endif diff --git a/deal.II/source/fe/fe_tools.cc b/deal.II/source/fe/fe_tools.cc index ec3cc55d50..dfa3fda6c7 100644 --- a/deal.II/source/fe/fe_tools.cc +++ b/deal.II/source/fe/fe_tools.cc @@ -359,8 +359,8 @@ namespace FETools template void compute_block_renumbering ( const FiniteElement &element, - std::vector &renumbering, - std::vector &block_data, + std::vector &renumbering, + std::vector &block_data, bool return_start_indices) { Assert(renumbering.size() == element.dofs_per_cell, @@ -396,7 +396,7 @@ namespace FETools //TODO:[GK] This does not work for a single RT for (unsigned int i=0; i + std::pair indices = element.system_to_block_index(i); renumbering[i] = start_indices[indices.first] +indices.second; diff --git a/deal.II/source/fe/fe_tools.inst.in b/deal.II/source/fe/fe_tools.inst.in index f54ca54f59..981bd71c24 100644 --- a/deal.II/source/fe/fe_tools.inst.in +++ b/deal.II/source/fe/fe_tools.inst.in @@ -20,7 +20,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS template void compute_block_renumbering ( const FiniteElement& , - std::vector&, std::vector&, bool); + std::vector&, std::vector&, bool); template void compute_projection_matrices diff --git a/deal.II/source/multigrid/mg_tools.cc b/deal.II/source/multigrid/mg_tools.cc index f543a81a0c..d014a814a2 100644 --- a/deal.II/source/multigrid/mg_tools.cc +++ b/deal.II/source/multigrid/mg_tools.cc @@ -1059,7 +1059,7 @@ namespace MGTools count_dofs_per_block ( const DH &dof_handler, std::vector > &dofs_per_block, - std::vector target_block) + std::vector target_block) { const FiniteElement &fe = dof_handler.get_fe(); const unsigned int n_blocks = fe.n_blocks(); diff --git a/deal.II/source/multigrid/mg_tools.inst.in b/deal.II/source/multigrid/mg_tools.inst.in index 8e42bcdc6a..eb1926c14b 100644 --- a/deal.II/source/multigrid/mg_tools.inst.in +++ b/deal.II/source/multigrid/mg_tools.inst.in @@ -91,10 +91,10 @@ for (deal_II_dimension : DIMENSIONS) std::vector); template void count_dofs_per_block ( const DoFHandler&, std::vector >&, - std::vector); + std::vector); template void count_dofs_per_block ( const MGDoFHandler&, std::vector >&, - std::vector); + std::vector); #if deal_II_dimension > 1 template void make_boundary_list( -- 2.39.5