From 1c013a7e3810dc73f1d23bad8d8fd50d09abf691 Mon Sep 17 00:00:00 2001 From: angelrca Date: Tue, 2 Jun 2015 16:32:24 +0200 Subject: [PATCH] VectorTools::interpolate changed --- .../deal.II/numerics/vector_tools.templates.h | 120 +++++++++--------- 1 file changed, 61 insertions(+), 59 deletions(-) diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index 60fbd05842..0de44897bb 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -111,7 +111,7 @@ namespace VectorTools for (unsigned int fe_index=0; fe_indexis_locally_owned()) { const unsigned int fe_index = cell->active_fe_index(); - - // for each cell: - // get location of finite element - // support_points - fe_values.reinit(cell); - const std::vector > &support_points = - fe_values.get_present_fe_values().get_quadrature_points(); - - // pick out the representative - // support points - rep_points.resize (dofs_of_rep_points[fe_index].size()); - for (unsigned int j=0; jget_dof_indices (dofs_on_cell); - - - if (fe_is_system) - { - // get function values at - // these points. Here: get - // all components - function_values_system[fe_index] - .resize (n_rep_points[fe_index], - Vector (fe[fe_index].n_components())); - function.vector_value_list (rep_points, - function_values_system[fe_index]); - // distribute the function - // values to the global - // vector - for (unsigned int i=0; i > &support_points = + fe_values.get_present_fe_values().get_quadrature_points(); + + // pick out the representative + // support points + rep_points.resize (dofs_of_rep_points[fe_index].size()); + for (unsigned int j=0; jget_dof_indices (dofs_on_cell); + + + if (fe_is_system) + { + // get function values at + // these points. Here: get + // all components + function_values_system[fe_index] + .resize (n_rep_points[fe_index], + Vector (fe[fe_index].n_components())); + function.vector_value_list (rep_points, + function_values_system[fe_index]); + // distribute the function + // values to the global + // vector + for (unsigned int i=0; i