From: turcksin Date: Sat, 2 Mar 2013 23:23:07 +0000 (+0000) Subject: Compile using unsigned long long int for global_dof_index but still a lot of warnings... X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=2e32b7f64aa26acab03735b7c2d14c00b9d70591;p=dealii-svn.git Compile using unsigned long long int for global_dof_index but still a lot of warnings to clean. git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28712 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/base/utilities.h b/deal.II/include/deal.II/base/utilities.h index 8eb09f00bf..292b9c22f9 100644 --- a/deal.II/include/deal.II/base/utilities.h +++ b/deal.II/include/deal.II/base/utilities.h @@ -324,6 +324,27 @@ namespace Utilities std::vector invert_permutation (const std::vector &permutation); + /** + * Given a permutation vector (i.e. a + * vector $p_0\ldots p_{N-1}$ where each + * $p_i\in [0,N)$ and $p_i\neq p_j$ for + * $i\neq j$), produce the reverse + * permutation $q_i=N-1-p_i$. + */ + std::vector + reverse_permutation (const std::vector &permutation); + + /** + * Given a permutation vector (i.e. a + * vector $p_0\ldots p_{N-1}$ where each + * $p_i\in [0,N)$ and $p_i\neq p_j$ for + * $i\neq j$), produce the inverse + * permutation $q_0\ldots q_{N-1}$ so that + * $q_{p_i}=p_{q_i}=i$. + */ + std::vector + invert_permutation (const std::vector &permutation); + /** * A namespace for utility functions that * probe system properties. diff --git a/deal.II/include/deal.II/dofs/dof_renumbering.h b/deal.II/include/deal.II/dofs/dof_renumbering.h index 9ed959c454..f14d277bb2 100644 --- a/deal.II/include/deal.II/dofs/dof_renumbering.h +++ b/deal.II/include/deal.II/dofs/dof_renumbering.h @@ -920,7 +920,7 @@ namespace DoFRenumbering */ template unsigned int - compute_block_wise (std::vector &new_dof_indices, + compute_block_wise (std::vector &new_dof_indices, const ITERATOR &start, const ENDITERATOR &end); diff --git a/deal.II/include/deal.II/dofs/dof_tools.h b/deal.II/include/deal.II/dofs/dof_tools.h index cf6ee8659b..37418c2e5d 100644 --- a/deal.II/include/deal.II/dofs/dof_tools.h +++ b/deal.II/include/deal.II/dofs/dof_tools.h @@ -1919,7 +1919,7 @@ namespace DoFTools const DH &dof_handler, const unsigned int level, const std::vector &selected_dofs = std::vector(), - unsigned int offset = 0); + types::global_dof_index offset = 0); /** * Create an incidence matrix that @@ -2297,8 +2297,8 @@ namespace DoFTools void count_dofs_per_block (const DH &dof, std::vector &dofs_per_block, - const std::vector &target_block - = std::vector()); + const std::vector &target_block + = std::vector()); /** * @deprecated See the previous @@ -2697,7 +2697,7 @@ namespace DoFTools void map_dofs_to_support_points (const Mapping &mapping, const DoFHandler &dof_handler, - std::map > &support_points); + std::map > &support_points); /** * Same as the previous function but for the hp case. @@ -2706,7 +2706,7 @@ namespace DoFTools void map_dofs_to_support_points (const dealii::hp::MappingCollection &mapping, const hp::DoFHandler &dof_handler, - std::map > &support_points); + std::map > &support_points); /** diff --git a/deal.II/include/deal.II/grid/grid_generator.h b/deal.II/include/deal.II/grid/grid_generator.h index 455129df0b..054d3c6735 100644 --- a/deal.II/include/deal.II/grid/grid_generator.h +++ b/deal.II/include/deal.II/grid/grid_generator.h @@ -622,7 +622,7 @@ public: const double inner_radius = .25, const double outer_radius = .5, const double L = .5, - const unsigned int repetition = 1, + const size_type repetition = 1, const bool colorize = false); /** diff --git a/deal.II/include/deal.II/hp/dof_handler.h b/deal.II/include/deal.II/hp/dof_handler.h index 751da3e0c4..1581eeddd4 100644 --- a/deal.II/include/deal.II/hp/dof_handler.h +++ b/deal.II/include/deal.II/hp/dof_handler.h @@ -395,7 +395,7 @@ namespace hp * Return the number of degrees of freedom * located on the boundary. */ - unsigned int n_boundary_dofs () const; + types::global_dof_index n_boundary_dofs () const; /** * Return the number of degrees diff --git a/deal.II/include/deal.II/lac/sparse_direct.h b/deal.II/include/deal.II/lac/sparse_direct.h index 5149d54f5a..bd21d92236 100644 --- a/deal.II/include/deal.II/lac/sparse_direct.h +++ b/deal.II/include/deal.II/lac/sparse_direct.h @@ -911,8 +911,8 @@ private: /** * Control values set by MA47ID. */ - double CNTL[2]; - size_type ICNTL[7]; + double CNTL[2]; + unsigned int ICNTL[7]; /** * Info field filled by the MA47 @@ -971,8 +971,8 @@ private: * Call the ma47id function * with the given args. */ - void call_ma47id (double *CNTL, - size_type *ICNTL); + void call_ma47id (double *CNTL, + unsigned int *ICNTL); /** * Call the ma47ad function @@ -992,31 +992,31 @@ private: * Call the ma47bd function * with the given args. */ - void call_ma47bd (const size_type *n_rows, - const size_type *n_nonzero_elements, - const size_type *column_numbers, - double *A, - const size_type *LA, - size_type *IW, - const size_type *LIW, - const size_type *KEEP, - const double *CNTL, - const size_type *ICNTL, - size_type *IW1, - int *INFO); + void call_ma47bd (const size_type *n_rows, + const size_type *n_nonzero_elements, + const size_type *column_numbers, + double *A, + const size_type *LA, + size_type *IW, + const size_type *LIW, + const size_type *KEEP, + const double *CNTL, + const unsigned int *ICNTL, + size_type *IW1, + int *INFO); /** * Call the ma47bd function * with the given args. */ - void call_ma47cd (const size_type *n_rows, - const double *A, - const size_type *LA, - const size_type *IW, - const size_type *LIW, - double *rhs_and_solution, - size_type *IW1, - const size_type *ICNTL); + void call_ma47cd (const size_type *n_rows, + const double *A, + const size_type *LA, + const size_type *IW, + const size_type *LIW, + double *rhs_and_solution, + size_type *IW1, + const unsigned int *ICNTL); }; diff --git a/deal.II/include/deal.II/lac/sparse_vanka.templates.h b/deal.II/include/deal.II/lac/sparse_vanka.templates.h index 519cfceabb..af510e256a 100644 --- a/deal.II/include/deal.II/lac/sparse_vanka.templates.h +++ b/deal.II/include/deal.II/lac/sparse_vanka.templates.h @@ -70,7 +70,8 @@ SparseVanka::compute_inverses () selected.end(), true); - const size_type n_inverses_per_thread = std::max(n_inverses / n_threads, 1U); + const size_type n_inverses_per_thread = std::max(n_inverses / n_threads, + static_cast (1U)); // set up start and end index // for each of the @@ -391,7 +392,8 @@ SparseBlockVanka::compute_dof_masks (const SparseMatrix &M, selected.end(), true); - const size_type n_inverses_per_block = std::max(n_inverses / n_blocks, 1U); + const size_type n_inverses_per_block = std::max(n_inverses / n_blocks, + static_cast (1U)); // precompute the splitting points std::vector > intervals (n_blocks); diff --git a/deal.II/include/deal.II/lac/vector.templates.h b/deal.II/include/deal.II/lac/vector.templates.h index 03234afcc0..99b17993c1 100644 --- a/deal.II/include/deal.II/lac/vector.templates.h +++ b/deal.II/include/deal.II/lac/vector.templates.h @@ -1383,7 +1383,11 @@ void Vector::block_write (std::ostream &out) const const size_type sz = size(); char buf[16]; - std::sprintf(buf, "%d", sz); +#ifdef DEAL_II_USE_LARGE_INDEX_TYPE + std::sprintf(buf, "%llu", sz); +#else + std::sprintf(buf, "%u", sz); +#endif std::strcat(buf, "\n["); out.write(buf, std::strlen(buf)); diff --git a/deal.II/include/deal.II/multigrid/mg_tools.h b/deal.II/include/deal.II/multigrid/mg_tools.h index 532d90a419..90f3aa482c 100644 --- a/deal.II/include/deal.II/multigrid/mg_tools.h +++ b/deal.II/include/deal.II/multigrid/mg_tools.h @@ -177,7 +177,7 @@ namespace MGTools void count_dofs_per_block (const DH &dof_handler, std::vector > &dofs_per_block, - std::vector target_block = std::vector()); + std::vector target_block = std::vector()); /** * Count the dofs component-wise diff --git a/deal.II/include/deal.II/multigrid/mg_transfer.templates.h b/deal.II/include/deal.II/multigrid/mg_transfer.templates.h index c02da23a5b..57a75435e9 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer.templates.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer.templates.h @@ -69,7 +69,7 @@ namespace template void reinit_vector (const dealii::DoFHandler &mg_dof, - std::vector target_component, + std::vector target_component, MGLevelObject > &v) { const unsigned int n_blocks = mg_dof.get_fe().n_blocks(); diff --git a/deal.II/include/deal.II/multigrid/mg_transfer_block.h b/deal.II/include/deal.II/multigrid/mg_transfer_block.h index 19b97e44b7..284081e121 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer_block.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer_block.h @@ -128,13 +128,13 @@ protected: /** * Start index of each block. */ - std::vector block_start; + std::vector block_start; /** * Start index of each block on * all levels. */ - std::vector > mg_block_start; + std::vector > mg_block_start; /** * Call build_matrices() diff --git a/deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h b/deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h index 6e55196f1e..fd260b6e99 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h @@ -99,7 +99,7 @@ MGTransferSelect::copy_from_mg ( //the block back to dst. const unsigned int n_blocks = *std::max_element(target_component.begin(), target_component.end()) + 1; - std::vector dofs_per_block (n_blocks); + std::vector dofs_per_block (n_blocks); DoFTools::count_dofs_per_block (mg_dof_handler, dofs_per_block, target_component); BlockVector tmp; tmp.reinit(n_blocks); diff --git a/deal.II/source/base/utilities.cc b/deal.II/source/base/utilities.cc index 954fe4d448..51754749eb 100644 --- a/deal.II/source/base/utilities.cc +++ b/deal.II/source/base/utilities.cc @@ -464,6 +464,42 @@ namespace Utilities return out; } + std::vector + reverse_permutation (const std::vector &permutation) + { + const unsigned long long int n = permutation.size(); + + std::vector out (n); + for (unsigned long long int i=0; i + invert_permutation (const std::vector &permutation) + { + const unsigned long long int n = permutation.size(); + + std::vector out (n, numbers::invalid_unsigned_int); + + for (unsigned long long int i=0; i std::vector diff --git a/deal.II/source/dofs/dof_renumbering.cc b/deal.II/source/dofs/dof_renumbering.cc index 14ffc1614c..e0c3402c8e 100644 --- a/deal.II/source/dofs/dof_renumbering.cc +++ b/deal.II/source/dofs/dof_renumbering.cc @@ -773,13 +773,13 @@ namespace DoFRenumbering types::global_dof_index next_free_index = 0; for (unsigned int component=0; component::const_iterator + const typename std::vector::const_iterator begin_of_component = component_to_dof_map[component].begin(), end_of_component = component_to_dof_map[component].end(); next_free_index = shifts[component]; - 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_renumbering.inst.in b/deal.II/source/dofs/dof_renumbering.inst.in index 51be1bd94d..cfde20f725 100644 --- a/deal.II/source/dofs/dof_renumbering.inst.in +++ b/deal.II/source/dofs/dof_renumbering.inst.in @@ -28,16 +28,16 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS (DoFHandler&, const bool, const bool, - const std::vector&); + const std::vector&); template void compute_Cuthill_McKee > - (std::vector&, + (std::vector&, const DoFHandler&, const bool, const bool, - const std::vector&); + const std::vector&); template void component_wise @@ -130,16 +130,16 @@ namespace DoFRenumbering (hp::DoFHandler&, const bool, const bool, - const std::vector&); + const std::vector&); template void compute_Cuthill_McKee > - (std::vector&, + (std::vector&, const hp::DoFHandler&, const bool, const bool, - const std::vector&); + const std::vector&); template void component_wise @@ -183,7 +183,7 @@ namespace DoFRenumbering template void compute_cell_wise > - (std::vector&, std::vector&, + (std::vector&, std::vector&, const DoFHandler&, const std::vector::active_cell_iterator>&); @@ -194,7 +194,7 @@ namespace DoFRenumbering template void compute_cell_wise > - (std::vector&, std::vector&, + (std::vector&, std::vector&, const DoFHandler&, unsigned int, const std::vector::level_cell_iterator>&); @@ -205,7 +205,7 @@ namespace DoFRenumbering template void compute_downstream > - (std::vector&,std::vector&, + (std::vector&,std::vector&, const DoFHandler&, const Point&, const bool); @@ -217,7 +217,7 @@ namespace DoFRenumbering template void compute_clockwise_dg > - (std::vector&, const DoFHandler&, + (std::vector&, const DoFHandler&, const Point&, const bool); // Renumbering for hp::DoFHandler @@ -229,7 +229,7 @@ namespace DoFRenumbering template void compute_cell_wise > - (std::vector&, std::vector&, + (std::vector&, std::vector&, const hp::DoFHandler&, const std::vector::active_cell_iterator>&); @@ -254,7 +254,7 @@ namespace DoFRenumbering template void compute_downstream > - (std::vector&,std::vector&, + (std::vector&,std::vector&, const hp::DoFHandler&, const Point&, const bool); @@ -268,7 +268,7 @@ namespace DoFRenumbering template void compute_clockwise_dg > - (std::vector&, + (std::vector&, const hp::DoFHandler&, const Point&, const bool); @@ -296,7 +296,7 @@ namespace DoFRenumbering template void compute_random > - (std::vector&, + (std::vector&, const DoFHandler &); template @@ -313,14 +313,14 @@ namespace DoFRenumbering template void compute_sort_selected_dofs_back > - (std::vector&, + (std::vector&, const DoFHandler &, const std::vector &); template void compute_sort_selected_dofs_back > - (std::vector&, + (std::vector&, const MGDoFHandler &, const std::vector &, const unsigned int); @@ -332,7 +332,7 @@ namespace DoFRenumbering template void compute_random > - (std::vector&, + (std::vector&, const hp::DoFHandler &); template @@ -343,7 +343,7 @@ namespace DoFRenumbering template void compute_sort_selected_dofs_back > - (std::vector&, + (std::vector&, const hp::DoFHandler &, const std::vector &); @@ -357,14 +357,14 @@ namespace DoFRenumbering (DoFHandler&, const unsigned int, const bool, - const std::vector&); + const std::vector&); template void Cuthill_McKee > (MGDoFHandler&, const unsigned int, const bool, - const std::vector&); + const std::vector&); \} // namespace DoFRenumbering #endif diff --git a/deal.II/source/dofs/dof_tools.cc b/deal.II/source/dofs/dof_tools.cc index bdcccec352..fbbfc216fb 100644 --- a/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/source/dofs/dof_tools.cc @@ -3588,7 +3588,7 @@ namespace DoFTools local_selected_dofs[i] = component_mask[local_component_asssociation[i]]; // then loop over all cells and do work - std::vector indices(fe.dofs_per_cell); + std::vector indices(fe.dofs_per_cell); typename DH::level_cell_iterator c; for (c = dof.begin(level) ; c != dof.end(level) ; ++ c) { @@ -4333,9 +4333,9 @@ namespace DoFTools void resolve_components (const FiniteElement &fe, const std::vector &dofs_by_component, - const std::vector &target_component, + const std::vector &target_component, const bool only_once, - std::vector &dofs_per_component, + std::vector &dofs_per_component, unsigned int &component) { for (unsigned int b=0; b &fe_collection, const std::vector &dofs_by_component, - const std::vector &target_component, + const std::vector &target_component, const bool only_once, - std::vector &dofs_per_component, + std::vector &dofs_per_component, unsigned int &component) { // assert that all elements in the collection have the same structure @@ -4440,7 +4440,7 @@ namespace DoFTools const DH &dof_handler, std::vector &dofs_per_component, bool only_once, - std::vector target_component) + std::vector target_component) { const unsigned int n_components = dof_handler.get_fe().n_components(); @@ -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()); @@ -4597,7 +4597,7 @@ namespace DoFTools void count_dofs_per_component (const DoFHandler &dof_handler, std::vector &dofs_per_component, - std::vector target_component) + std::vector target_component) { count_dofs_per_component (dof_handler, dofs_per_component, false, target_component); @@ -5233,12 +5233,12 @@ namespace DoFTools weights, weight_mapping); // now compute the requested representation - const unsigned int n_global_parm_dofs + const types::global_dof_index n_global_parm_dofs = std::count_if (weight_mapping.begin(), weight_mapping.end(), std::bind2nd (std::not_equal_to (), -1)); // first construct the inverse mapping of weight_mapping - std::vector inverse_weight_mapping (n_global_parm_dofs, + std::vector inverse_weight_mapping (n_global_parm_dofs, DoFHandler::invalid_dof_index); for (unsigned int i=0; i indices; + std::vector indices; unsigned int i=0; for (cell=dof_handler.begin(level); cell != endc; ++i, ++cell) @@ -5703,7 +5703,7 @@ namespace DoFTools typename DH::level_cell_iterator cell; typename DH::level_cell_iterator endc = dof_handler.end(level); - std::vector indices; + std::vector indices; std::vector exclude; for (cell=dof_handler.begin(level); cell != endc; ++cell) @@ -5750,7 +5750,7 @@ namespace DoFTools typename DH::level_cell_iterator pcell = dof_handler.begin(level-1); typename DH::level_cell_iterator endc = dof_handler.end(level-1); - std::vector indices; + std::vector indices; std::vector exclude; for (unsigned int block = 0; pcell != endc; ++pcell) @@ -5824,7 +5824,7 @@ namespace DoFTools numbers::invalid_unsigned_int); // Estimate for the number of dofs at this point - std::vector vertex_dof_count(dof_handler.get_tria().n_vertices(), 0); + std::vector vertex_dof_count(dof_handler.get_tria().n_vertices(), 0); // Identify all vertices active on this level and remember some data // about them @@ -5872,7 +5872,7 @@ namespace DoFTools // into the sparsity pattern. block_list.reinit(vertex_dof_count.size(), dof_handler.n_dofs(level), vertex_dof_count); - std::vector indices; + std::vector indices; std::vector exclude; for (cell=dof_handler.begin(level); cell != endc; ++cell) diff --git a/deal.II/source/dofs/dof_tools.inst.in b/deal.II/source/dofs/dof_tools.inst.in index a18d3cfc7d..d2c6af3fb3 100644 --- a/deal.II/source/dofs/dof_tools.inst.in +++ b/deal.II/source/dofs/dof_tools.inst.in @@ -100,7 +100,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) DoFTools::make_boundary_sparsity_pattern,SP> (const hp::DoFHandler& dof, const FunctionMap::type &boundary_indicators, - const std::vector &dof_to_boundary_mapping, + const std::vector &dof_to_boundary_mapping, SP &sparsity); template void @@ -115,11 +115,11 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) template void DoFTools::make_cell_patches,SP> - (SP&, const DoFHandler&, unsigned int, const std::vector&, unsigned int); + (SP&, const DoFHandler&, const unsigned int, const std::vector&, types::global_dof_index); template void DoFTools::make_cell_patches,SP> - (SP&, const MGDoFHandler&, unsigned int, const std::vector&, unsigned int); + (SP&, const MGDoFHandler&, const unsigned int, const std::vector&, types::global_dof_index); #if deal_II_dimension > 1 @@ -203,27 +203,27 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) template void DoFTools::make_boundary_sparsity_pattern,SP> (const DoFHandler& dof, - const std::vector &, + const std::vector &, SP &); //template void //DoFTools::make_boundary_sparsity_pattern,SP> //(const hp::DoFHandler& dof, - // const std::vector &, + // const std::vector &, // SP &); template void DoFTools::make_boundary_sparsity_pattern,SP> (const DoFHandler& dof, const FunctionMap::type &boundary_indicators, - const std::vector &dof_to_boundary_mapping, + const std::vector &dof_to_boundary_mapping, SP &sparsity); //template void //DoFTools::make_boundary_sparsity_pattern,SP> //(const hp::DoFHandler& dof, // const FunctionMap::type &boundary_indicators, - // const std::vector &dof_to_boundary_mapping, + // const std::vector &dof_to_boundary_mapping, // SP &sparsity); #endif @@ -280,27 +280,27 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) template void DoFTools::make_boundary_sparsity_pattern,SP> (const DoFHandler<1,3>& dof, - const std::vector &, + const std::vector &, SP &); //template void //DoFTools::make_boundary_sparsity_pattern,SP> //(const hp::DoFHandler<1,3>& dof, - // const std::vector &, + // const std::vector &, // SP &); template void DoFTools::make_boundary_sparsity_pattern,SP> (const DoFHandler<1,3>& dof, const FunctionMap<3>::type &boundary_indicators, - const std::vector &dof_to_boundary_mapping, + const std::vector &dof_to_boundary_mapping, SP &sparsity); //template void //DoFTools::make_boundary_sparsity_pattern,SP> //(const hp::DoFHandler<1,3>& dof, // const FunctionMap<3>::type &boundary_indicators, - // const std::vector &dof_to_boundary_mapping, + // const std::vector &dof_to_boundary_mapping, // SP &sparsity); #endif @@ -799,13 +799,13 @@ template void DoFTools::count_dofs_per_component > ( const DoFHandler&, - std::vector&, bool, std::vector); + std::vector&, bool, std::vector); template void DoFTools::count_dofs_per_component > ( const hp::DoFHandler&, - std::vector&, bool, std::vector); + std::vector&, bool, std::vector); #if deal_II_dimension < 3 @@ -813,13 +813,13 @@ template void DoFTools::count_dofs_per_component > ( const DoFHandler&, - std::vector&, bool, std::vector); + std::vector&, bool, std::vector); template void DoFTools::count_dofs_per_component > ( const hp::DoFHandler&, - std::vector&, bool, std::vector); + std::vector&, bool, std::vector); template void @@ -845,13 +845,13 @@ template void DoFTools::count_dofs_per_component > ( const DoFHandler<1,3>&, - std::vector&, bool, std::vector); + std::vector&, bool, std::vector); template void DoFTools::count_dofs_per_component > ( const hp::DoFHandler<1,3>&, - std::vector&, bool, std::vector); + std::vector&, bool, std::vector); template void @@ -876,28 +876,28 @@ template void DoFTools::count_dofs_per_block > ( const DoFHandler&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); template void DoFTools::count_dofs_per_block > ( const hp::DoFHandler&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); template void DoFTools::count_dofs_per_block > ( const MGDoFHandler&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); template void DoFTools::count_dofs_per_component ( const DoFHandler&, - std::vector&, std::vector); + std::vector&, std::vector); template void @@ -921,13 +921,13 @@ void DoFTools::map_dof_to_boundary_indices > (const DoFHandler &, const std::set &, - std::vector &); + std::vector &); template void DoFTools::map_dof_to_boundary_indices > (const DoFHandler &, - std::vector &); + std::vector &); @@ -936,13 +936,13 @@ void DoFTools::map_dof_to_boundary_indices > (const hp::DoFHandler &, const std::set &, - std::vector &); + std::vector &); template void DoFTools::map_dof_to_boundary_indices > (const hp::DoFHandler &, - std::vector &); + std::vector &); @@ -967,7 +967,7 @@ void DoFTools::map_dofs_to_support_points (const Mapping&, const DoFHandler&, - std::map >&); + std::map >&); template @@ -975,7 +975,7 @@ void DoFTools::map_dofs_to_support_points (const hp::MappingCollection&, const hp::DoFHandler&, - std::map >&); + std::map >&); #if deal_II_dimension < 3 @@ -998,36 +998,36 @@ void DoFTools::map_dofs_to_support_points (const Mapping&, const DoFHandler&, - std::map >&); + std::map >&); template void DoFTools::map_dofs_to_support_points (const hp::MappingCollection&, const hp::DoFHandler&, - std::map >&); + std::map >&); template void DoFTools::count_dofs_per_block > ( const DoFHandler&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); template void DoFTools::count_dofs_per_block > ( const hp::DoFHandler&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); template void DoFTools::count_dofs_per_block > ( const MGDoFHandler&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); #endif @@ -1045,22 +1045,22 @@ template void DoFTools::count_dofs_per_block > ( const DoFHandler<1,3>&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); template void DoFTools::count_dofs_per_block > ( const hp::DoFHandler<1,3>&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); template void DoFTools::count_dofs_per_block > ( const MGDoFHandler<1,3>&, - std::vector&, - const std::vector &); + std::vector&, + const std::vector &); #endif @@ -1114,13 +1114,13 @@ void DoFTools::map_dof_to_boundary_indices > (const DoFHandler &, const std::set &, - std::vector &); + std::vector &); template void DoFTools::map_dof_to_boundary_indices > (const DoFHandler &, - std::vector &); + std::vector &); template @@ -1134,13 +1134,13 @@ DoFTools::extract_hanging_node_dofs DoFTools::map_dof_to_boundary_indices > (const hp::DoFHandler &, const std::set &, - std::vector &); + std::vector &); template void DoFTools::map_dof_to_boundary_indices > (const hp::DoFHandler &, - std::vector &); + std::vector &); #endif @@ -1151,13 +1151,13 @@ void DoFTools::map_dof_to_boundary_indices > (const DoFHandler<1,3> &, const std::set &, - std::vector &); + std::vector &); template void DoFTools::map_dof_to_boundary_indices > (const DoFHandler<1,3> &, - std::vector &); + std::vector &); template @@ -1171,13 +1171,13 @@ DoFTools::extract_hanging_node_dofs // DoFTools::map_dof_to_boundary_indices > // (const hp::DoFHandler<1,3> &, // const std::set &, -// std::vector &); +// std::vector &); // template // void // DoFTools::map_dof_to_boundary_indices > // (const hp::DoFHandler<1,3> &, -// std::vector &); +// std::vector &); #endif diff --git a/deal.II/source/grid/grid_generator.cc b/deal.II/source/grid/grid_generator.cc index fa4125060e..da5e36333f 100644 --- a/deal.II/source/grid/grid_generator.cc +++ b/deal.II/source/grid/grid_generator.cc @@ -2808,7 +2808,7 @@ GridGenerator::hyper_shell (Triangulation<3> &tria, const Point<3> &p, const double inner_radius, const double outer_radius, - const unsigned int n, + const size_type n, const bool colorize) { Assert ((inner_radius > 0) && (inner_radius < outer_radius), @@ -3037,7 +3037,7 @@ GridGenerator::half_hyper_shell (Triangulation<3> &tria, const Point<3> ¢er, const double inner_radius, const double outer_radius, - const unsigned int n, + const size_type n, const bool colorize) { Assert ((inner_radius > 0) && (inner_radius < outer_radius), @@ -3183,7 +3183,7 @@ void GridGenerator::quarter_hyper_shell (Triangulation<3> &tria, const Point<3> ¢er, const double inner_radius, const double outer_radius, - const unsigned int n, + const size_type n, const bool colorize) { Assert ((inner_radius > 0) && (inner_radius < outer_radius), @@ -3370,7 +3370,7 @@ merge_triangulations (const Triangulation &triangulation_1, // throw out duplicated vertices from the two meshes // and create the triangulation SubCellData subcell_data; - std::vector considered_vertices; + std::vector considered_vertices; GridTools::delete_duplicated_vertices (vertices, cells, subcell_data, considered_vertices); result.clear (); result.create_triangulation (vertices, cells, subcell_data); diff --git a/deal.II/source/grid/grid_generator.inst.in b/deal.II/source/grid/grid_generator.inst.in index 5444c06e09..a579b33217 100644 --- a/deal.II/source/grid/grid_generator.inst.in +++ b/deal.II/source/grid/grid_generator.inst.in @@ -73,14 +73,14 @@ for (deal_II_dimension : DIMENSIONS) template void GridGenerator::subdivided_parallelepiped ( Triangulation&, - const unsigned int, + const size_type, const Point (&) [deal_II_dimension], const bool); template void GridGenerator::subdivided_parallelepiped ( Triangulation&, - const unsigned int [deal_II_dimension], + const size_type [deal_II_dimension], const Point (&) [deal_II_dimension], const bool); @@ -88,7 +88,7 @@ for (deal_II_dimension : DIMENSIONS) template void GridGenerator:: laplace_transformation (Triangulation &, - const std::map > &); + const std::map > &); #endif diff --git a/deal.II/source/grid/grid_tools.cc b/deal.II/source/grid/grid_tools.cc index d27093c073..90db4382ce 100644 --- a/deal.II/source/grid/grid_tools.cc +++ b/deal.II/source/grid/grid_tools.cc @@ -605,7 +605,7 @@ namespace GridTools template void - laplace_transform (const std::map > &new_points, + laplace_transform (const std::map > &new_points, Triangulation &triangulation) { //TODO: Move implementation of this function into the current diff --git a/deal.II/source/grid/grid_tools.inst.in b/deal.II/source/grid/grid_tools.inst.in index 22aed5c106..0a1d6e7558 100644 --- a/deal.II/source/grid/grid_tools.inst.in +++ b/deal.II/source/grid/grid_tools.inst.in @@ -157,7 +157,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS #if deal_II_dimension == deal_II_space_dimension template void - laplace_transform (const std::map > &new_points, + laplace_transform (const std::map > &new_points, Triangulation &triangulation); template diff --git a/deal.II/source/hp/dof_handler.cc b/deal.II/source/hp/dof_handler.cc index ae1d246e04..608635a483 100644 --- a/deal.II/source/hp/dof_handler.cc +++ b/deal.II/source/hp/dof_handler.cc @@ -575,8 +575,9 @@ namespace internal for (unsigned int level=0; leveln_levels(); ++level) { dof_handler.levels[level]->dof_object.dof_offsets - = std::vector (dof_handler.tria->n_raw_lines(level), - DoFHandler::invalid_dof_index); + = std::vector ( + dof_handler.tria->n_raw_lines(level), + DoFHandler::invalid_dof_index); types::global_dof_index next_free_dof = 0; for (typename DoFHandler::active_cell_iterator @@ -691,8 +692,9 @@ namespace internal for (unsigned int level=0; leveln_levels(); ++level) { dof_handler.levels[level]->dof_object.dof_offsets - = std::vector (dof_handler.tria->n_raw_quads(level), - DoFHandler::invalid_dof_index); + = std::vector ( + dof_handler.tria->n_raw_quads(level), + DoFHandler::invalid_dof_index); types::global_dof_index next_free_dof = 0; for (typename DoFHandler::active_cell_iterator @@ -842,7 +844,7 @@ namespace internal // active ones will have a // non-invalid value later on dof_handler.faces->lines.dof_offsets - = std::vector (dof_handler.tria->n_raw_lines(), + = std::vector (dof_handler.tria->n_raw_lines(), DoFHandler::invalid_dof_index); dof_handler.faces->lines.dofs = std::vector (n_line_slots, @@ -1055,7 +1057,7 @@ namespace internal for (unsigned int level=0; leveln_levels(); ++level) { dof_handler.levels[level]->dof_object.dof_offsets - = std::vector (dof_handler.tria->n_raw_hexs(level), + = std::vector (dof_handler.tria->n_raw_hexs(level), DoFHandler::invalid_dof_index); types::global_dof_index next_free_dof = 0; @@ -1210,7 +1212,7 @@ namespace internal if (true) { dof_handler.faces->quads.dof_offsets - = std::vector (dof_handler.tria->n_raw_quads(), + = std::vector (dof_handler.tria->n_raw_quads(), DoFHandler::invalid_dof_index); dof_handler.faces->quads.dofs = std::vector (n_quad_slots, @@ -1477,8 +1479,10 @@ namespace internal unsigned int max_couplings_between_dofs (const DoFHandler<1,spacedim> &dof_handler) { - return std::min(3*dof_handler.finite_elements->max_dofs_per_vertex() + - 2*dof_handler.finite_elements->max_dofs_per_line(), dof_handler.n_dofs()); + return std::min(static_cast (3* + dof_handler.finite_elements->max_dofs_per_vertex() + + 2*dof_handler.finite_elements->max_dofs_per_line()), + dof_handler.n_dofs()); } @@ -1509,7 +1513,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: @@ -1562,7 +1566,7 @@ namespace internal // can anyone give better estimate here? 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.finite_elements->max_dofs_per_vertex() + 7*6*7*3*dof_handler.finite_elements->max_dofs_per_line() + @@ -2673,8 +2677,8 @@ namespace hp Assert (number_cache.n_global_dofs < std::numeric_limits::max (), ExcMessage ("Global number of degrees of freedom is too large.")); number_cache.n_locally_owned_dofs_per_processor - = std::vector (1, - (unsigned int) number_cache.n_global_dofs); + = std::vector (1, + (types::global_dof_index) number_cache.n_global_dofs); number_cache.locally_owned_dofs_per_processor = std::vector (1, diff --git a/deal.II/source/hp/dof_handler.inst.in b/deal.II/source/hp/dof_handler.inst.in index cb3e175963..8272116607 100644 --- a/deal.II/source/hp/dof_handler.inst.in +++ b/deal.II/source/hp/dof_handler.inst.in @@ -21,21 +21,21 @@ for (deal_II_dimension : DIMENSIONS) template class DoFHandler; template - unsigned int + types::global_dof_index DoFHandler::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; template void - DoFHandler::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; + DoFHandler::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #if deal_II_dimension >= 2 template - unsigned int + types::global_dof_index DoFHandler::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; template void - DoFHandler::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; + DoFHandler::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #endif #endif @@ -43,43 +43,43 @@ for (deal_II_dimension : DIMENSIONS) template class DoFHandler<1, 3>; template -unsigned int +types::global_dof_index DoFHandler<1,3>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; template void -DoFHandler<1,3>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, unsigned int) const; +DoFHandler<1,3>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #endif template -unsigned int +types::global_dof_index DoFHandler::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; #if deal_II_dimension >= 2 template -unsigned int +types::global_dof_index DoFHandler::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; #if deal_II_dimension >= 3 template -unsigned int +types::global_dof_index DoFHandler::get_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; #endif #endif template void -DoFHandler::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; +DoFHandler::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #if deal_II_dimension >= 2 template void -DoFHandler::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; +DoFHandler::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #if deal_II_dimension >= 3 template void -DoFHandler::set_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; +DoFHandler::set_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #endif #endif \} diff --git a/deal.II/source/lac/full_matrix.inst.in b/deal.II/source/lac/full_matrix.inst.in index 0a08486187..d04b444c29 100644 --- a/deal.II/source/lac/full_matrix.inst.in +++ b/deal.II/source/lac/full_matrix.inst.in @@ -47,7 +47,7 @@ for (S1, S2 : REAL_SCALARS) template void FullMatrix::fill ( - const FullMatrix&, unsigned, unsigned, unsigned, unsigned); + const FullMatrix&, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index); template void FullMatrix::add (const S1, const FullMatrix&); template @@ -59,12 +59,12 @@ for (S1, S2 : REAL_SCALARS) const S1, const FullMatrix&); template void FullMatrix::add ( - const FullMatrix&, S1, unsigned, unsigned,unsigned, unsigned); + const FullMatrix&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index); template void FullMatrix::Tadd (const S1, const FullMatrix&); template void FullMatrix::Tadd ( - const FullMatrix&, S1, unsigned, unsigned, unsigned, unsigned); + const FullMatrix&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index); template void FullMatrix::equ (const S1, const FullMatrix&); template @@ -93,8 +93,8 @@ for (S1, S2 : REAL_SCALARS) template void FullMatrix::fill_permutation ( const FullMatrix&, - const std::vector&, - const std::vector&); + const std::vector&, + const std::vector&); template void FullMatrix::vmult( Vector&, const Vector&, bool) const; @@ -155,7 +155,7 @@ for (S1, S2 : COMPLEX_SCALARS) { template void FullMatrix::fill ( - const FullMatrix&, unsigned, unsigned, unsigned, unsigned); + const FullMatrix&, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index); template void FullMatrix::add (const S1, const FullMatrix&); template @@ -167,12 +167,13 @@ for (S1, S2 : COMPLEX_SCALARS) const S1, const FullMatrix&); template void FullMatrix::add ( - const FullMatrix&, S1, unsigned, unsigned,unsigned, unsigned); + const FullMatrix&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index); template void FullMatrix::Tadd (const S1, const FullMatrix&); template void FullMatrix::Tadd ( - const FullMatrix&, S1, unsigned, unsigned, unsigned, unsigned); + const FullMatrix&, S1, types::global_dof_index, types::global_dof_index, + types::global_dof_index, types::global_dof_index); template void FullMatrix::equ (const S1, const FullMatrix&); template @@ -197,8 +198,8 @@ for (S1, S2 : COMPLEX_SCALARS) template void FullMatrix::fill_permutation ( const FullMatrix&, - const std::vector&, - const std::vector&); + const std::vector&, + const std::vector&); template void FullMatrix::vmult( Vector&, const Vector&, bool) const; diff --git a/deal.II/source/lac/sparse_direct.cc b/deal.II/source/lac/sparse_direct.cc index d150412cd1..dd62be2cbd 100644 --- a/deal.II/source/lac/sparse_direct.cc +++ b/deal.II/source/lac/sparse_direct.cc @@ -150,7 +150,7 @@ namespace HSL extern "C" void ma47id_ (double *, - size_type *) + unsigned int *) { AssertThrow (false, ExcMessage("You can only use the HSL functions after putting " @@ -167,7 +167,7 @@ namespace HSL size_type *, const size_type *, size_type *, - const size_type *, + const unsigned int *, double *, int *) { @@ -188,7 +188,7 @@ namespace HSL const size_type *, const size_type *, const double *, - const size_type *, + const unsigned int *, size_type *, double *, int *) @@ -209,7 +209,7 @@ namespace HSL double *, double *, size_type *, - const size_type *) + const unsigned int *) { AssertThrow (false, ExcMessage("You can only use the HSL functions after putting " @@ -1409,8 +1409,8 @@ SparseDirectMA47::fill_A (const SparseMatrix &matrix) void -SparseDirectMA47::call_ma47id (double *CNTL, // length 2 - size_type *ICNTL) // length 7 +SparseDirectMA47::call_ma47id (double *CNTL, // length 2 + unsigned int *ICNTL) // length 7 { HSL::MA47::ma47id_ (CNTL, ICNTL); } diff --git a/deal.II/source/lac/sparse_matrix.inst.in b/deal.II/source/lac/sparse_matrix.inst.in index a958f23424..53eee70191 100644 --- a/deal.II/source/lac/sparse_matrix.inst.in +++ b/deal.II/source/lac/sparse_matrix.inst.in @@ -32,16 +32,16 @@ for (S1, S2 : REAL_SCALARS) template void SparseMatrix::add (const S1, const SparseMatrix &); - template void SparseMatrix::add (const unsigned int, - const unsigned int, - const unsigned int *, + template void SparseMatrix::add (const size_type, + const size_type, + const size_type *, const S2 *, const bool, const bool); - template void SparseMatrix::set (const unsigned int, - const unsigned int, - const unsigned int *, + template void SparseMatrix::set (const size_type, + const size_type, + const size_type *, const S2 *, const bool); } @@ -95,13 +95,13 @@ for (S1, S2 : REAL_SCALARS) const S1) const; template void SparseMatrix:: PSOR (Vector &, - const std::vector&, - const std::vector&, + const std::vector&, + const std::vector&, const S1) const; template void SparseMatrix:: TPSOR (Vector &, - const std::vector&, - const std::vector&, + const std::vector&, + const std::vector&, const S1) const; template void SparseMatrix:: Jacobi_step (Vector &, @@ -215,13 +215,13 @@ for (S1, S2, S3: REAL_SCALARS) // const S1) const; // template void SparseMatrix:: // PSOR (Vector &, -// const std::vector&, -// const std::vector&, +// const std::vector&, +// const std::vector&, // const S1) const; // template void SparseMatrix:: // TPSOR (Vector &, -// const std::vector&, -// const std::vector&, +// const std::vector&, +// const std::vector&, // const S1) const; // template void SparseMatrix:: // SOR_step (Vector &, diff --git a/deal.II/source/lac/sparsity_pattern.cc b/deal.II/source/lac/sparsity_pattern.cc index 26fbeb23ea..9d80edb4dc 100644 --- a/deal.II/source/lac/sparsity_pattern.cc +++ b/deal.II/source/lac/sparsity_pattern.cc @@ -384,7 +384,7 @@ SparsityPattern::reinit (const size_type m, std::size_t vec_len = 0; for (size_type i=0; i (1U)) : row_lengths[i]), n); @@ -462,7 +462,7 @@ SparsityPattern::reinit (const size_type m, for (size_type i=1; i<=rows; ++i) rowstart[i] = rowstart[i-1] + (store_diagonal_first_in_row ? - std::max(std::min(row_lengths[i-1],n),1U) : + std::max(std::min(row_lengths[i-1],n),static_cast (1U)) : std::min(row_lengths[i-1],n)); Assert ((rowstart[rows]==vec_len) || diff --git a/deal.II/source/multigrid/mg_tools.cc b/deal.II/source/multigrid/mg_tools.cc index 1ed223ab8c..f543a81a0c 100644 --- a/deal.II/source/multigrid/mg_tools.cc +++ b/deal.II/source/multigrid/mg_tools.cc @@ -582,8 +582,8 @@ namespace MGTools ExcDimensionMismatch (sparsity.n_cols(), n_dofs)); const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; - std::vector dofs_on_this_cell(dofs_per_cell); - std::vector dofs_on_other_cell(dofs_per_cell); + std::vector dofs_on_this_cell(dofs_per_cell); + std::vector dofs_on_other_cell(dofs_per_cell); typename DoFHandler::cell_iterator cell = dof.begin(level), endc = dof.end(level); for (; cell!=endc; ++cell) diff --git a/deal.II/source/multigrid/mg_tools.inst.in b/deal.II/source/multigrid/mg_tools.inst.in index 9a0b2b8c85..8e42bcdc6a 100644 --- a/deal.II/source/multigrid/mg_tools.inst.in +++ b/deal.II/source/multigrid/mg_tools.inst.in @@ -84,23 +84,23 @@ for (deal_II_dimension : DIMENSIONS) #endif template void count_dofs_per_component ( - const DoFHandler&, std::vector >&, - bool, std::vector); + const DoFHandler&, std::vector >&, + bool, std::vector); template void count_dofs_per_component ( - const DoFHandler&, std::vector >&, - std::vector); + const DoFHandler&, std::vector >&, + std::vector); template void count_dofs_per_block ( - const DoFHandler&, std::vector >&, - std::vector); + const DoFHandler&, std::vector >&, + std::vector); template void count_dofs_per_block ( - const MGDoFHandler&, std::vector >&, - std::vector); + const MGDoFHandler&, std::vector >&, + std::vector); #if deal_II_dimension > 1 template void make_boundary_list( const DoFHandler&, const FunctionMap::type&, - std::vector >&, + std::vector >&, const ComponentMask &); #endif @@ -122,18 +122,18 @@ for (deal_II_dimension : DIMENSIONS) template void extract_non_interface_dofs (const DoFHandler & mg_dof_handler, - std::vector > &non_interface_dofs); + std::vector > &non_interface_dofs); #if deal_II_dimension < 3 template void count_dofs_per_block ( const DoFHandler&, - std::vector >&, std::vector); + std::vector >&, std::vector); #endif #if deal_II_dimension == 3 template void count_dofs_per_block ( const DoFHandler<1,3>&, - std::vector >&, std::vector); + std::vector >&, std::vector); #endif \} } diff --git a/deal.II/source/multigrid/mg_transfer_component.inst.in b/deal.II/source/multigrid/mg_transfer_component.inst.in index bd9ad33004..272f78d852 100644 --- a/deal.II/source/multigrid/mg_transfer_component.inst.in +++ b/deal.II/source/multigrid/mg_transfer_component.inst.in @@ -21,7 +21,7 @@ void MGTransferSelect::build_matrices unsigned int, unsigned int, const std::vector&, const std::vector&, - const std::vector >&); + const std::vector >&); template void MGTransferSelect::build_matrices @@ -30,7 +30,7 @@ void MGTransferSelect::build_matrices unsigned int, unsigned int, const std::vector&, const std::vector&, - const std::vector >&); + const std::vector >&); template void MGTransferSelect::copy_to_mg (