From e39fdc453b4b451fa65b522f99e6f3470633956f Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Tue, 19 Dec 2000 13:21:43 +0000 Subject: [PATCH] Fix one bug. Several more still lurking somewhere in the deep. git-svn-id: https://svn.dealii.org/trunk@3570 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/source/dofs/dof_tools.cc | 10 ++++++---- 1 file changed, 6 insertions(+), 4 deletions(-) diff --git a/deal.II/deal.II/source/dofs/dof_tools.cc b/deal.II/deal.II/source/dofs/dof_tools.cc index c7dc364a41..a787ec7eb4 100644 --- a/deal.II/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/deal.II/source/dofs/dof_tools.cc @@ -1224,7 +1224,7 @@ DoFTools::compute_intergrid_constraints (const DoFHandler &coa Assert (next_free_index == n_parameters_on_fine_grid, ExcInternalError()); }; - + // for each cell on the parameter grid: // find out which degrees of freedom on the @@ -1242,7 +1242,6 @@ DoFTools::compute_intergrid_constraints (const DoFHandler &coa coarse_to_fine_grid_map, parameter_dofs, weight_mapping, weights); - // ok, now we have all weights for each // dof on the fine grid. if in debug // mode lets see if everything went smooth, @@ -1389,7 +1388,7 @@ DoFTools::compute_intergrid_weights (const DoFHandler &coarse_ cell_intervals = Threads::split_range (coarse_grid.begin_active(), coarse_grid.end(), multithread_info.n_default_threads); - + Threads::ThreadManager thread_manager; for (unsigned int i=0; i &coars // aliases to the finite elements // used by the dof handlers: const FiniteElement &coarse_fe = coarse_grid.get_fe(); + + const unsigned int coarse_dofs_per_cell_component + = coarse_fe.base_element(coarse_fe.component_to_base(coarse_component)).dofs_per_cell; // for each cell on the parameter grid: // find out which degrees of freedom on the @@ -1507,7 +1509,7 @@ DoFTools::compute_intergrid_weights_1 (const DoFHandler &coars // cell and check whether they // are interesting for us for (unsigned int local_parameter_dof=0; - local_parameter_dof