*/
void assemble(VECTOR& global,
const BlockVector<double>& local,
- const std::vector<unsigned int>& dof);
+ const std::vector<types::global_dof_index>& dof);
/**
* The global matrices,
void assemble(
MatrixBlock<MATRIX>& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2);
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2);
/**
* The global matrices,
void assemble(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2,
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2,
bool transpose = false);
/**
void assemble_fluxes(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2);
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2);
/**
* Assemble a single local
void assemble_up(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2);
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2);
/**
* Assemble a single local
void assemble_down(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2);
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2);
/**
* Assemble a single local
void assemble_in(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2);
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2);
/**
* Assemble a single local
void assemble_out(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2);
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2);
/**
* The level matrices,
ResidualLocalBlocksToGlobalBlocks<VECTOR>::assemble(
VECTOR& global,
const BlockVector<double>& local,
- const std::vector<unsigned int>& dof)
+ const std::vector<types::global_dof_index>& dof)
{
if(constraints == 0)
{
MatrixLocalBlocksToGlobalBlocks<MATRIX, number>::assemble(
MatrixBlock<MATRIX>& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2)
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2)
{
if(constraints == 0)
{
else
{
const BlockIndices &bi = this->block_info->local();
- std::vector<unsigned int> sliced_row_indices (bi.block_size(block_row));
+ std::vector<types::global_dof_index> sliced_row_indices (bi.block_size(block_row));
for(unsigned int i=0; i<sliced_row_indices.size(); ++i)
sliced_row_indices[i] = dof1[bi.block_start(block_row)+i];
- std::vector<unsigned int> sliced_col_indices (bi.block_size(block_col));
+ std::vector<types::global_dof_index> sliced_col_indices (bi.block_size(block_col));
for(unsigned int i=0; i<sliced_col_indices.size(); ++i)
sliced_col_indices[i] = dof2[bi.block_start(block_col)+i];
{
// Row and column index of
// the block we are dealing with
- const unsigned int row = matrices->block(i).row;
- const unsigned int col = matrices->block(i).column;
+ const types::global_dof_index row = matrices->block(i).row;
+ const types::global_dof_index col = matrices->block(i).column;
assemble(matrices->block(i), info.matrix(i,false).matrix, row, col, info.indices, info.indices);
}
{
// Row and column index of
// the block we are dealing with
- const unsigned int row = matrices->block(i).row;
- const unsigned int col = matrices->block(i).column;
+ const types::global_dof_index row = matrices->block(i).row;
+ const types::global_dof_index col = matrices->block(i).column;
assemble(matrices->block(i), info1.matrix(i,false).matrix, row, col, info1.indices, info1.indices);
assemble(matrices->block(i), info1.matrix(i,true).matrix, row, col, info1.indices, info2.indices);
MGMatrixLocalBlocksToGlobalBlocks<MATRIX, number>::assemble(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2,
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2,
bool transpose)
{
for (unsigned int j=0;j<local.n_rows();++j)
MGMatrixLocalBlocksToGlobalBlocks<MATRIX, number>::assemble_fluxes(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2)
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2)
{
for (unsigned int j=0;j<local.n_rows();++j)
for (unsigned int k=0;k<local.n_cols();++k)
MGMatrixLocalBlocksToGlobalBlocks<MATRIX, number>::assemble_up(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2)
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2)
{
for (unsigned int j=0;j<local.n_rows();++j)
for (unsigned int k=0;k<local.n_cols();++k)
MGMatrixLocalBlocksToGlobalBlocks<MATRIX, number>::assemble_down(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2)
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2)
{
for (unsigned int j=0;j<local.n_rows();++j)
for (unsigned int k=0;k<local.n_cols();++k)
MGMatrixLocalBlocksToGlobalBlocks<MATRIX, number>::assemble_in(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2)
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2)
{
// AssertDimension(local.n(), dof1.size());
// AssertDimension(local.m(), dof2.size());
MGMatrixLocalBlocksToGlobalBlocks<MATRIX, number>::assemble_out(
MATRIX& global,
const FullMatrix<number>& local,
- unsigned int block_row,
- unsigned int block_col,
- const std::vector<unsigned int>& dof1,
- const std::vector<unsigned int>& dof2,
- unsigned int level1,
- unsigned int level2)
+ const unsigned int block_row,
+ const unsigned int block_col,
+ const std::vector<types::global_dof_index>& dof1,
+ const std::vector<types::global_dof_index>& dof2,
+ const unsigned int level1,
+ const unsigned int level2)
{
// AssertDimension(local.n(), dof1.size());
// AssertDimension(local.m(), dof2.size());