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
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
* into #matrix.
*/
void assemble(const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2);
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2);
/**
* The global matrix being
*/
void assemble(MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2);
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2);
/**
* Assemble a single matrix
*/
void assemble(MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level);
/**
void assemble_up(MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level = numbers::invalid_unsigned_int);
/**
* Assemble a single matrix
void assemble_down(MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level = numbers::invalid_unsigned_int);
/**
void assemble_in(MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level = numbers::invalid_unsigned_int);
/**
void assemble_out(MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level = numbers::invalid_unsigned_int);
/**
template <class MATRIX>
inline void
MatrixSimple<MATRIX>::assemble(const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2)
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2)
{
AssertDimension(M.m(), i1.size());
AssertDimension(M.n(), i2.size());
MGMatrixSimple<MATRIX>::assemble(
MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2)
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2)
{
AssertDimension(M.m(), i1.size());
AssertDimension(M.n(), i2.size());
MGMatrixSimple<MATRIX>::assemble(
MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level)
{
AssertDimension(M.m(), i1.size());
MGMatrixSimple<MATRIX>::assemble_up(
MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level)
{
AssertDimension(M.n(), i1.size());
MGMatrixSimple<MATRIX>::assemble_down(
MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level)
{
AssertDimension(M.m(), i1.size());
MGMatrixSimple<MATRIX>::assemble_in(
MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level)
{
AssertDimension(M.m(), i1.size());
MGMatrixSimple<MATRIX>::assemble_out(
MATRIX &G,
const FullMatrix<double> &M,
- const std::vector<unsigned int> &i1,
- const std::vector<unsigned int> &i2,
+ const std::vector<types::global_dof_index> &i1,
+ const std::vector<types::global_dof_index> &i2,
const unsigned int level)
{
AssertDimension(M.n(), i1.size());