From: turcksin Date: Wed, 6 Feb 2013 01:02:48 +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=735182f552b48eac8a16482aead73f4ad4900d91;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_3@28240 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/files b/deal.II/files index 68f2ea5ff7..f9d015f544 100644 --- a/deal.II/files +++ b/deal.II/files @@ -62,15 +62,15 @@ UWE source/dofs/dof_objects.cc HELENE source/dofs/dof_renumbering.cc UWE source/dofs/dof_tools.cc TIMO source/dofs/number_cache.cc -source/fe/fe_abf.cc -source/fe/fe_bdm.cc +BRUNO source/fe/fe_abf.cc +BRUNO source/fe/fe_bdm.cc GK source/fe/fe.cc KAINAN source/fe/fe_data.cc -source/fe/fe_dgp.cc -source/fe/fe_dgp_monomial.cc -source/fe/fe_dgp_nonparametric.cc -source/fe/fe_dgq.cc -source/fe/fe_dg_vector.cc +BRUNO source/fe/fe_dgp.cc +BRUNO source/fe/fe_dgp_monomial.cc +BRUNO source/fe/fe_dgp_nonparametric.cc +BRUNO source/fe/fe_dgq.cc +BRUNO source/fe/fe_dg_vector.cc KAINAN source/fe/fe_face.cc KAINAN source/fe/fe_nedelec.cc KAINAN source/fe/fe_nothing.cc @@ -469,22 +469,22 @@ include/deal.II/matrix_free/fe_evaluation.h include/deal.II/matrix_free/helper_functions.h include/deal.II/matrix_free/mapping_info.h include/deal.II/matrix_free/mapping_info.templates.h -include/deal.II/matrix_free/matrix_free.h -include/deal.II/matrix_free/matrix_free.templates.h -include/deal.II/matrix_free/shape_info.h -include/deal.II/matrix_free/shape_info.templates.h +BRUNO include/deal.II/matrix_free/matrix_free.h +BRUNO include/deal.II/matrix_free/matrix_free.templates.h +BRUNO include/deal.II/matrix_free/shape_info.h +BRUNO include/deal.II/matrix_free/shape_info.templates.h WOLFGANG include/deal.II/meshworker/assembler.h WOLFGANG include/deal.II/meshworker/dof_info.h WOLFGANG include/deal.II/meshworker/dof_info.templates.h WOLFGANG include/deal.II/meshworker/functional.h -include/deal.II/meshworker/integration_info.h -include/deal.II/meshworker/integration_info.templates.h -include/deal.II/meshworker/local_results.h +BRUNO include/deal.II/meshworker/integration_info.h +BRUNO include/deal.II/meshworker/integration_info.templates.h +BRUNO include/deal.II/meshworker/local_results.h WOLFGANG include/deal.II/meshworker/loop.h WOLFGANG include/deal.II/meshworker/output.h -include/deal.II/meshworker/simple.h -include/deal.II/meshworker/vector_selector.h -include/deal.II/meshworker/vector_selector.templates.h +BRUNO include/deal.II/meshworker/simple.h +BRUNO include/deal.II/meshworker/vector_selector.h +BRUNO include/deal.II/meshworker/vector_selector.templates.h include/deal.II/multigrid/mg_base.h include/deal.II/multigrid/mg_block_smoother.h include/deal.II/multigrid/mg_coarse.h diff --git a/deal.II/include/deal.II/meshworker/simple.h b/deal.II/include/deal.II/meshworker/simple.h index 49789fb7bb..464a1cd16b 100644 --- a/deal.II/include/deal.II/meshworker/simple.h +++ b/deal.II/include/deal.II/meshworker/simple.h @@ -237,8 +237,8 @@ namespace MeshWorker * into #matrix. */ void assemble(const FullMatrix &M, - const std::vector &i1, - const std::vector &i2); + const std::vector &i1, + const std::vector &i2); /** * The global matrix being @@ -402,8 +402,8 @@ namespace MeshWorker */ void assemble(MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2); + const std::vector &i1, + const std::vector &i2); /** * Assemble a single matrix @@ -411,8 +411,8 @@ namespace MeshWorker */ void assemble(MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level); /** @@ -422,8 +422,8 @@ namespace MeshWorker void assemble_up(MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level = numbers::invalid_unsigned_int); /** * Assemble a single matrix @@ -432,8 +432,8 @@ namespace MeshWorker void assemble_down(MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level = numbers::invalid_unsigned_int); /** @@ -443,8 +443,8 @@ namespace MeshWorker void assemble_in(MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level = numbers::invalid_unsigned_int); /** @@ -454,8 +454,8 @@ namespace MeshWorker void assemble_out(MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level = numbers::invalid_unsigned_int); /** @@ -728,8 +728,8 @@ namespace MeshWorker template inline void MatrixSimple::assemble(const FullMatrix &M, - const std::vector &i1, - const std::vector &i2) + const std::vector &i1, + const std::vector &i2) { AssertDimension(M.m(), i1.size()); AssertDimension(M.n(), i2.size()); @@ -880,8 +880,8 @@ namespace MeshWorker MGMatrixSimple::assemble( MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2) + const std::vector &i1, + const std::vector &i2) { AssertDimension(M.m(), i1.size()); AssertDimension(M.n(), i2.size()); @@ -911,8 +911,8 @@ namespace MeshWorker MGMatrixSimple::assemble( MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level) { AssertDimension(M.m(), i1.size()); @@ -964,8 +964,8 @@ namespace MeshWorker MGMatrixSimple::assemble_up( MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level) { AssertDimension(M.n(), i1.size()); @@ -994,8 +994,8 @@ namespace MeshWorker MGMatrixSimple::assemble_down( MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level) { AssertDimension(M.m(), i1.size()); @@ -1024,8 +1024,8 @@ namespace MeshWorker MGMatrixSimple::assemble_in( MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level) { AssertDimension(M.m(), i1.size()); @@ -1067,8 +1067,8 @@ namespace MeshWorker MGMatrixSimple::assemble_out( MATRIX &G, const FullMatrix &M, - const std::vector &i1, - const std::vector &i2, + const std::vector &i1, + const std::vector &i2, const unsigned int level) { AssertDimension(M.n(), i1.size()); diff --git a/deal.II/source/fe/fe_abf.cc b/deal.II/source/fe/fe_abf.cc index 3b756c5112..6e9ba46271 100644 --- a/deal.II/source/fe/fe_abf.cc +++ b/deal.II/source/fe/fe_abf.cc @@ -290,7 +290,7 @@ FE_ABF::initialize_support_points (const unsigned int deg) // This function is the same Raviart-Thomas interpolation performed by // interpolate. Still, we cannot use interpolate, since it was written -// for smooth functions. Thefunctions interpolated here are not +// for smooth functions. The functions interpolated here are not // smooth, maybe even not continuous. Therefore, we must double the // number of quadrature points in each direction in order to integrate // only smooth functions.