From 3eec369159c80b0a81f379dd75fc83ff0d2f526e Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Sat, 16 Jan 2016 17:46:28 -0600 Subject: [PATCH] WIP kelly fix --- .../numerics/error_estimator.templates.h | 37 +++++++++++++------ 1 file changed, 26 insertions(+), 11 deletions(-) diff --git a/include/deal.II/numerics/error_estimator.templates.h b/include/deal.II/numerics/error_estimator.templates.h index facca6b8fe..483cd2c5f0 100644 --- a/include/deal.II/numerics/error_estimator.templates.h +++ b/include/deal.II/numerics/error_estimator.templates.h @@ -234,11 +234,13 @@ namespace internal fe_face_values_neighbor (mapping, finite_element, face_quadratures, - update_gradients), + update_gradients| + update_normal_vectors), fe_subface_values (mapping, finite_element, face_quadratures, - update_gradients), + update_gradients| + update_normal_vectors), phi (n_solution_vectors, std::vector > (face_quadratures.max_n_quadrature_points(), @@ -340,7 +342,8 @@ namespace internal integrate_over_face (ParallelData ¶llel_data, const typename DoFHandlerType::face_iterator &face, - dealii::hp::FEFaceValues &fe_face_values_cell) + dealii::hp::FEFaceValues &fe_face_values_cell, + const std::vector > & other_normals) { const unsigned int n_q_points = parallel_data.psi[0].size(), n_components = parallel_data.finite_element.n_components(), @@ -348,11 +351,11 @@ namespace internal if (face->at_boundary() == false) { - // compute the jump in the gradients - for (unsigned int n=0; nat_boundary() == false) + { + // compute the jump in the gradients + for (unsigned int n=0; nface(neighbor_neighbor)] = - integrate_over_face (parallel_data, face, fe_face_values); + integrate_over_face (parallel_data, face, fe_face_values, + fe_subface_values.get_present_fe_values().get_all_normal_vectors()); for (unsigned int i = 0; i < local_face_integrals[neighbor_child->face(neighbor_neighbor)].size(); i++) local_face_integrals[neighbor_child->face(neighbor_neighbor)][i] *= factor; } -- 2.39.5