LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << " Number of degrees of freedom: " << mg_dof_handler.n_dofs()
<< std::endl;
{
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
BlockInfo bi;
bi.initialize(mgdof);
bi.initialize_local(mgdof);
{
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
BlockInfo bi;
bi.initialize(mgdof, false, false);
bi.initialize_local(mgdof);
DoFHandler<dim> dof;
dof.initialize(tr, fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
const unsigned int level = tr.n_levels() - 1;
DoFHandler<dim> dof;
dof.initialize(tr, fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
const unsigned int level = tr.n_levels() - 1;
DoFHandler<dim> dof;
dof.initialize(tr, fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
const unsigned int level = tr.n_levels() - 1;
DoFHandler<dim> dof;
dof.initialize(tr, fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
const unsigned int level = tr.n_levels() - 1;
DoFHandler<dim> dof;
dof.initialize(tr, fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
const unsigned int level = tr.n_levels() - 1;
DoFHandler<dim> dof;
dof.initialize(tr, fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
for (unsigned int level = 0; level < tr.n_global_levels(); ++level)
{
FESystem<dim> e1(FE_Q<dim>(2), 2, FE_DGQ<dim>(1), 1);
mgdof.distribute_dofs(e1);
- mgdof.distribute_mg_dofs(e1);
+ mgdof.distribute_mg_dofs();
check_renumbering(mgdof, false);
mgdof.clear();
FESystem<dim> e2(FE_DGP<dim>(2), 2, FE_DGQ<dim>(1), 1);
mgdof.distribute_dofs(e2);
- mgdof.distribute_mg_dofs(e2);
+ mgdof.distribute_mg_dofs();
check_renumbering(mgdof, true);
mgdof.clear();
}
DoFHandler<dim> dof(tr);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
check_renumbering(dof);
}
DoFHandler<dim> dof(tr);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
check_renumbering(dof);
}
}
DoFHandler<dim> dof(tr);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
check_renumbering(dof);
}
DoFHandler<dim> dof(tr);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
check_renumbering(dof);
}
}
FE_Q<dim> fe(1);
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
// Print dofs before reordering
FESystem<dim> element(FE_Q<dim>(2), 1, FE_Nedelec<dim>(0), 1);
DoFHandler<dim> dof(tr);
dof.distribute_dofs(element);
- dof.distribute_mg_dofs(element);
+ dof.distribute_mg_dofs();
// try all possible component
// masks, which we encode as bit
FESystem<dim> element(FE_Q<dim>(2), 1, FE_Nedelec<dim>(0), 1);
DoFHandler<dim> dof(tr);
dof.distribute_dofs(element);
- dof.distribute_mg_dofs(element);
+ dof.distribute_mg_dofs();
// try all possible block
// masks, which we encode as bit
pressure_mass_matrix.clear();
// The main DoFHandler only needs active DoFs, so we are not calling
- // distribute_mg_dofs() here
+ // distribute_mg_dofs();
dof_handler.distribute_dofs(fe);
// This block structure separates the dim velocity components from
{
DoFHandler<dim> dof(tr);
dof.distribute_dofs(finel);
- dof.distribute_mg_dofs(finel);
+ dof.distribute_mg_dofs();
MGTransferPrebuilt<Vector<double>> transfer;
transfer.build_matrices(dof);
DoFHandler<dim> dof(tr);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
dof.initialize_local_block_info();
for (unsigned int level = 0; level < tr.n_levels(); ++level)
DoFRenumbering::component_wise(dof, level);
DoFHandler<dim> dof(tr);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
dof.initialize_local_block_info();
mg::SparseMatrixCollection<double> mg;
mg.resize(0, tr.n_levels() - 1);
tr.refine_global(1);
deallog.push("1");
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
test_mesh(dofs);
deallog.pop();
tr.begin(1)->set_refine_flag();
tr.execute_coarsening_and_refinement();
deallog.push("2");
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
test_mesh(dofs);
deallog.pop();
tr.begin(2)->set_refine_flag();
tr.execute_coarsening_and_refinement();
deallog.push("3");
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
test_mesh(dofs);
deallog.pop();
}
tr.refine_global(1);
deallog.push("1");
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
test_mesh(dofs);
deallog.pop();
tr.begin(1)->set_refine_flag();
tr.execute_coarsening_and_refinement();
deallog.push("2");
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
test_mesh(dofs);
deallog.pop();
tr.begin(2)->set_refine_flag();
tr.execute_coarsening_and_refinement();
deallog.push("3");
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
test_mesh(dofs);
deallog.pop();
}
DoFHandler<dim> dofs(tr);
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
deallog << "DoFHandler " << dofs.n_dofs() << " levels";
for (unsigned int l = 0; l < tr.n_levels(); ++l)
deallog << ' ' << l << ':' << dofs.n_dofs(l);
DoFHandler<dim> dofs(tr);
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
deallog << "DoFHandler " << dofs.n_dofs() << " levels";
for (unsigned int l = 0; l < tr.n_levels(); ++l)
deallog << ' ' << l << ':' << dofs.n_dofs(l);
DoFHandler<dim> dofs(tr);
dofs.distribute_dofs(fe);
- dofs.distribute_mg_dofs(fe);
+ dofs.distribute_mg_dofs();
deallog << "DoFHandler " << dofs.n_dofs() << " levels";
for (unsigned int l = 0; l < tr.n_levels(); ++l)
deallog << ' ' << l << ':' << dofs.n_dofs(l);
FE_DGQ<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
deallog << "Number of DoFs: " << dof.n_dofs() << std::endl;
MappingQGeneric<dim> mapping(fe_degree + 1);
FE_DGQ<dim> fe(1);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
AffineConstraints<double> constraints;
constraints.close();
// setup DoFs
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
AffineConstraints<double> constraints;
VectorTools::interpolate_boundary_values(dof,
0,
FE_DGQ<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof);
}
FE_DGQ<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof, true);
}
FE_DGQ<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof, true);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
deallog.push("threaded");
do_test<dim, fe_degree, fe_degree + 1, Number>(dof, true);
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof, nbands);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, double>(dof);
}
FE_Q<dim> fe(fe_degree);
DoFHandler<dim> dof(tria);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
do_test<dim, fe_degree, fe_degree + 1, number>(dof);
}
mg_constraints.clear_elements();
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
deallog << "Number of degrees of freedom: " << dof_handler.n_dofs()
<< std::endl;
FE_Q<dim> fe(1);
DoFHandler<dim> dofh(tria);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
ScratchData scratch;
InteriorPenaltyProblem<dim>::setup_system()
{
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_set);
Assert(dofh.has_active_dofs() == true, ExcInternalError());
Assert(dofh.has_level_dofs() == false, ExcInternalError());
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
Assert(dofh.has_active_dofs() == true, ExcInternalError());
Assert(dofh.has_level_dofs() == true, ExcInternalError());
static const FE_DGP<dim> fe(0);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
{
for (unsigned int lvl = 0; lvl < tr.n_levels(); ++lvl)
static const FE_Q<dim> fe(1);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
{
for (unsigned int lvl = 0; lvl < tr.n_levels(); ++lvl)
static const FE_Q<dim> fe(1);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
{
for (unsigned int lvl = 0; lvl < tr.n_levels(); ++lvl)
static const FE_Q<dim> fe(1);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
{
for (unsigned int lvl = 0; lvl < tr.n_levels(); ++lvl)
FE_Q<dim> fe(1);
DoFHandler<dim> dof_handler(tria);
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
FE_Q<dim> fe(1);
DoFHandler<dim> dof_handler(tria);
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
FE_Q<dim> fe(1);
DoFHandler<dim> dof_handler(tria);
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
FE_Q<dim> fe(1);
DoFHandler<dim> dof_handler(tria);
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
deallog << "Number of cells: " << tria.n_global_active_cells() << std::endl
<< "Number of DoFs: " << dof_handler.n_dofs() << std::endl;
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
deallog << "Number of DoFs per level: ";
for (unsigned int level = 0; level < tria.n_global_levels(); ++level)
deallog << dof_handler.n_dofs(level) << " ";
FE_Q<dim> fe2(1);
DoFHandler<dim> dof_handler(tria);
dof_handler.distribute_dofs(fe1);
- dof_handler.distribute_mg_dofs(fe1);
+ dof_handler.distribute_mg_dofs();
dof_handler.distribute_dofs(fe2);
- dof_handler.distribute_mg_dofs(fe2);
+ dof_handler.distribute_mg_dofs();
deallog << "OK" << std::endl;
}
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
InteriorPenaltyProblem<dim>::setup_system()
{
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_set);
solution.reinit(dof_handler.locally_owned_dofs(), MPI_COMM_WORLD);
InteriorPenaltyProblem<dim>::setup_system()
{
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_set);
solution.reinit(dof_handler.locally_owned_dofs(), MPI_COMM_WORLD);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
std::vector<std::set<types::global_dof_index>> boundary_indices(
tr.n_levels());
DoFHandler<dim> dofh(tr);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs_ref;
{
DoFHandler<dim> dofhref(tr);
dofhref.distribute_dofs(fe);
- dofhref.distribute_mg_dofs(fe);
+ dofhref.distribute_mg_dofs();
// std::map<std::string,std::vector<types::global_dof_index> > dofmap;
std::map<std::string, std::vector<types::global_dof_index>> mgdofmap;
DoFHandler<dim> dofh(tr);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs_ref;
{
DoFHandler<dim> dofhref(tr);
dofhref.distribute_dofs(fe);
- dofhref.distribute_mg_dofs(fe);
+ dofhref.distribute_mg_dofs();
// std::map<std::string,std::vector<types::global_dof_index> > dofmap;
std::map<std::string, std::vector<types::global_dof_index>> mgdofmap;
DoFHandler<dim> dofh(tr);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
std::set<types::boundary_id> boundary_indicators;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
std::vector<std::vector<types::global_dof_index>> count(tr.n_levels());
MGTools::count_dofs_per_component(mgdof, count, false);
DoFHandler<dim> dof_handler(triangulation);
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
}
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
dofs(mgdof);
}
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
dofs(mgdof);
}
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
deallog << "check " << dim << " level distribute " << dof.has_active_dofs()
<< ' ' << dof.has_level_dofs() << std::endl;
DoFHandler<dim> dof(tr);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
std::vector<types::global_dof_index> dof_indices(fe.dofs_per_cell);
std::vector<types::global_dof_index> mg_dof_indices(fe.dofs_per_cell);
DoFHandler<dim> dof(tr);
dof.distribute_dofs(fe);
- dof.distribute_mg_dofs(fe);
+ dof.distribute_mg_dofs();
deallog << dim << "D OK" << std::endl;
}
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
locally_relevant_set);
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
locally_relevant_set);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
DoFHandler<dim> mgdof_renumbered(tr);
mgdof_renumbered.distribute_dofs(fe);
- mgdof_renumbered.distribute_mg_dofs(fe);
+ mgdof_renumbered.distribute_mg_dofs();
std::vector<unsigned int> block_component(4, 0);
block_component[2] = 1;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
DoFHandler<dim> mgdof_renumbered(tr);
mgdof_renumbered.distribute_dofs(fe);
- mgdof_renumbered.distribute_mg_dofs(fe);
+ mgdof_renumbered.distribute_mg_dofs();
std::vector<unsigned int> block_component(4, 0);
block_component[2] = 1;
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
mg_dof_handler_renumbered.distribute_dofs(fe);
- mg_dof_handler_renumbered.distribute_mg_dofs(fe);
+ mg_dof_handler_renumbered.distribute_mg_dofs();
std::vector<unsigned int> block_component(2 * dim, 0);
for (unsigned int c = dim; c < 2 * dim; ++c)
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler_renumbered.distribute_dofs(fe);
- mg_dof_handler_renumbered.distribute_mg_dofs(fe);
+ mg_dof_handler_renumbered.distribute_mg_dofs();
const unsigned int nlevels = triangulation.n_levels();
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
mg_dof_handler_renumbered.distribute_dofs(fe);
- mg_dof_handler_renumbered.distribute_mg_dofs(fe);
+ mg_dof_handler_renumbered.distribute_mg_dofs();
const unsigned int nlevels = triangulation.n_levels();
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
DoFRenumbering::component_wise(mgdof);
for (unsigned int l = 0; l < tr.n_levels(); ++l)
DoFRenumbering::component_wise(mgdof, l);
DoFHandler<dim> mg_dof_handler(tria);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
Point<dim> a;
a(0) = 1;
for (unsigned int level = 0; level < tria.n_levels(); ++level)
DoFHandler<dim> mg_dof_handler(tria);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
for (unsigned int level = 0; level < tria.n_levels(); ++level)
{
const types::global_dof_index n_dofs = mg_dof_handler.n_dofs(level);
DoFHandler<dim> dh(tria);
dh.distribute_dofs(fe);
- dh.distribute_mg_dofs(fe);
+ dh.distribute_mg_dofs();
deallog << "** before:" << std::endl;
{
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
for (unsigned int l = 0; l < triangulation.n_levels(); ++l)
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
mg_dof_handler.n_dofs(),
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
mg_dof_handler.n_dofs(),
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
mg_dof_handler.n_dofs(),
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
mg_dof_handler.n_dofs(),
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
for (unsigned int l = 0; l < triangulation.n_levels(); ++l)
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
locally_relevant_set);
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
locally_relevant_set);
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
locally_relevant_set);
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
sparsity_pattern.reinit(mg_dof_handler.n_dofs(),
mg_dof_handler.n_dofs(),
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
for (unsigned int l = 0; l < triangulation.n_levels(); ++l)
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs();
for (unsigned int l = 0; l < triangulation.n_levels(); ++l)
InteriorPenaltyProblem<dim>::setup_system()
{
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
types::global_dof_index n_dofs = dof_handler.n_dofs();
solution.reinit(n_dofs);
right_hand_side.reinit(n_dofs);
InteriorPenaltyProblem<dim>::setup_system()
{
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
types::global_dof_index n_dofs = dof_handler.n_dofs();
solution.reinit(n_dofs);
right_hand_side.reinit(n_dofs);
InteriorPenaltyProblem<dim>::setup_system()
{
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
types::global_dof_index n_dofs = dof_handler.n_dofs();
solution.reinit(n_dofs);
right_hand_side.reinit(n_dofs);
InteriorPenaltyProblem<dim>::setup_system()
{
dof_handler.distribute_dofs(fe);
- dof_handler.distribute_mg_dofs(fe);
+ dof_handler.distribute_mg_dofs();
types::global_dof_index n_dofs = dof_handler.n_dofs();
solution.reinit(n_dofs);
right_hand_side.reinit(n_dofs);
LaplaceProblem<dim>::setup_system()
{
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFTools::extract_locally_relevant_dofs(mg_dof_handler,
locally_relevant_set);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGTransferPrebuilt<Vector<double>> transfer;
transfer.build_matrices(mgdof);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGTransferPrebuilt<Vector<double>> transfer;
transfer.build_matrices(mgdof);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
DoFHandler<dim> mgdof_renumbered(tr);
mgdof_renumbered.distribute_dofs(fe);
- mgdof_renumbered.distribute_mg_dofs(fe);
+ mgdof_renumbered.distribute_mg_dofs();
std::vector<unsigned int> block_component(4, 0);
block_component[2] = 1;
DoFHandler<dim> dofh(tr);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
typedef TrilinosWrappers::MPI::Vector vector_t;
MGConstrainedDoFs mg_constrained_dofs;
DoFHandler<dim> dofh(tr);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
typedef TrilinosWrappers::MPI::Vector vector_t;
{}
MGTransferPrebuilt<vector_t> transfer;
DoFHandler<dim> dofh(tr);
dofh.distribute_dofs(fe);
- dofh.distribute_mg_dofs(fe);
+ dofh.distribute_mg_dofs();
typedef PETScWrappers::MPI::Vector vector_t;
{}
MGTransferPrebuilt<vector_t> transfer;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
ZeroFunction<dim> zero_function;
DoFHandler<dim> mgdof_1(tr);
mgdof_1.distribute_dofs(fe_1);
- mgdof_1.distribute_mg_dofs(fe_1);
+ mgdof_1.distribute_mg_dofs();
DoFHandler<dim> mgdof_2(tr);
mgdof_2.distribute_dofs(fe_2);
- mgdof_2.distribute_mg_dofs(fe_2);
+ mgdof_2.distribute_mg_dofs();
const std::vector<const DoFHandler<dim> *> mgdof_ptr{&mgdof_1, &mgdof_2};
DoFHandler<dim> mgdof(tr);
DoFHandler<dim> &dof = mgdof;
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
DoFRenumbering::component_wise(mgdof);
vector<types::global_dof_index> ndofs(fe.n_blocks());
DoFTools::count_dofs_per_block(mgdof, ndofs);
DoFHandler<dim> mgdof(tr);
DoFHandler<dim> &dof = mgdof;
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
DoFRenumbering::component_wise(mgdof);
vector<types::global_dof_index> ndofs(fe.n_blocks());
DoFTools::count_dofs_per_block(mgdof, ndofs);
DoFHandler<dim> mgdof(tr);
DoFHandler<dim> &dof = mgdof;
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
// Make sure all orderings are the
// same
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
Functions::ZeroFunction<dim> zero_function;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
Functions::ZeroFunction<dim> zero_function;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
ZeroFunction<dim> zero_function;
DoFHandler<dim> mgdof_1(tr);
mgdof_1.distribute_dofs(fe_1);
- mgdof_1.distribute_mg_dofs(fe_1);
+ mgdof_1.distribute_mg_dofs();
DoFHandler<dim> mgdof_2(tr);
mgdof_2.distribute_dofs(fe_2);
- mgdof_2.distribute_mg_dofs(fe_2);
+ mgdof_2.distribute_mg_dofs();
const std::vector<const DoFHandler<dim> *> mgdof_ptr{&mgdof_1, &mgdof_2};
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
Functions::ZeroFunction<dim> zero_function;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
// build reference
MGTransferPrebuilt<LinearAlgebra::distributed::Vector<double>>
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
// build reference
MGTransferPrebuilt<LinearAlgebra::distributed::Vector<double>>
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
Functions::ZeroFunction<dim> zero_function;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
// build reference
MGTransferPrebuilt<LinearAlgebra::distributed::Vector<double>>
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
// build matrix-free transfer
MGTransferMatrixFree<dim, Number> transfer;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
Tensor<1, dim> exponents_monomial;
for (unsigned int d = 0; d < dim; ++d)
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
Tensor<1, dim> exponents_monomial;
for (unsigned int d = 0; d < dim; ++d)
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
mg_constrained_dofs.initialize(mgdof);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
// build matrix-free transfer
MGTransferMatrixFree<dim, Number> transfer;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGTransferPrebuilt<Vector<double>> transfer;
transfer.build_matrices(mgdof);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
mg_constrained_dofs.initialize(mgdof);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
std::map<types::boundary_id, const Function<dim> *> dirichlet_boundary;
Functions::ZeroFunction<dim> homogeneous_dirichlet_bc(1);
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGConstrainedDoFs mg_constrained_dofs;
Functions::ZeroFunction<dim> zero_function;
DoFHandler<dim> mgdof(tr);
DoFHandler<dim> &dof = mgdof;
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
DoFRenumbering::component_wise(mgdof, target_component);
vector<types::global_dof_index> ndofs(
*std::max_element(target_component.begin(), target_component.end()) + 1);
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFRenumbering::component_wise(mg_dof_handler);
for (unsigned int level = 0; level < tr.n_levels(); ++level)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFRenumbering::component_wise(mg_dof_handler);
for (unsigned int level = 0; level < tr.n_levels(); ++level)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
DoFRenumbering::component_wise(mg_dof_handler);
for (unsigned int level = 0; level < tr.n_levels(); ++level)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
std::vector<unsigned int> block_component(3, 0);
block_component[2] = 1;
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
std::vector<unsigned int> block_component(5, 0);
block_component[2] = 1;
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl;
for (unsigned int l = 0; l < tr.n_levels(); ++l)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl;
for (unsigned int l = 0; l < tr.n_levels(); ++l)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl;
for (unsigned int l = 0; l < tr.n_levels(); ++l)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl;
for (unsigned int l = 0; l < tr.n_levels(); ++l)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl;
for (unsigned int l = 0; l < tr.n_levels(); ++l)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl;
for (unsigned int l = 0; l < tr.n_levels(); ++l)
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
std::vector<unsigned int> block_selected(3, 0);
block_selected[2] = 1;
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
std::vector<unsigned int> block_selected(3, 0);
block_selected[2] = 1;
DoFHandler<dim> mg_dof_handler(tr);
mg_dof_handler.distribute_dofs(fe);
- mg_dof_handler.distribute_mg_dofs(fe);
+ mg_dof_handler.distribute_mg_dofs();
std::vector<unsigned int> block_component(5, 0);
block_component[2] = 1;
DoFHandler<dim> mgdof(tr);
mgdof.distribute_dofs(fe);
- mgdof.distribute_mg_dofs(fe);
+ mgdof.distribute_mg_dofs();
MGTransferPrebuilt<TrilinosWrappers::MPI::Vector> transfer;
transfer.build_matrices(mgdof);