From: bangerth Date: Thu, 9 Jan 2014 00:02:39 +0000 (+0000) Subject: Fix more bugs. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=0fd4ebd0264ab8c78cf9a186b8e7c29f2b0ebcca;p=dealii-svn.git Fix more bugs. git-svn-id: https://svn.dealii.org/trunk@32180 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/source/fe/fe_values.cc b/deal.II/source/fe/fe_values.cc index 7e00704767..c7a95ede57 100644 --- a/deal.II/source/fe/fe_values.cc +++ b/deal.II/source/fe/fe_values.cc @@ -2373,7 +2373,18 @@ namespace internal const bool quadrature_points_fastest = false, const unsigned int component_multiple = 1) { + // initialize with zero + for (unsigned int i=0; i()); + + // see if there the current cell has DoFs at all, and if not + // then there is nothing else to do. const unsigned int dofs_per_cell = fe.dofs_per_cell; + if (dofs_per_cell == 0) + return; + + const unsigned int n_quadrature_points = dofs_per_cell > 0 ? shape_derivatives[0].size() : 0; const unsigned int n_components = fe.n_components(); @@ -2393,11 +2404,6 @@ namespace internal AssertDimension (derivatives[i].size(), result_components); } - // initialize with zero - for (unsigned int i=0; i()); - // add up contributions of trial functions. now check whether the shape // function is primitive or not. if it is, then set its only non-zero // component, otherwise loop over components diff --git a/tests/hp/do_function_derivatives_01.cc b/tests/hp/do_function_derivatives_01.cc new file mode 100644 index 0000000000..8c324d71a5 --- /dev/null +++ b/tests/hp/do_function_derivatives_01.cc @@ -0,0 +1,120 @@ +// --------------------------------------------------------------------- +// $Id$ +// +// Copyright (C) 2011 - 2014 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + + + +// testcase by Minh Do-Quang: a case where SolutionTransfer got into trouble +// in a couple of places when using FE_Nothing and FESystem. + +#include "../tests.h" +#include +#include +#include + +#include +#include + +#include + +#include +#include +#include +#include + +#include +#include +#include +#include + +#include + +#include + +#include + +using namespace dealii; + +int main() +{ + std::ofstream logfile("output"); + deallog.attach(logfile); + deallog.depth_console(0); + deallog.threshold_double(1.e-10); + + Triangulation<2> triangulation; + GridGenerator::hyper_cube (triangulation); + triangulation.refine_global (1); + + + hp::FECollection<2> fe_collection; + + fe_collection.push_back(FESystem<2>(FE_Q<2>(1), 1, FE_Q<2>(1), 1)); + fe_collection.push_back(FESystem<2>(FE_Nothing<2>(), 1, FE_Nothing<2>(), 1)); + + hp::DoFHandler<2> dof_handler(triangulation); + + // Assign FE to cells + hp::DoFHandler<2>::active_cell_iterator cell; + hp::DoFHandler<2>::active_cell_iterator endc = dof_handler.end(); + + + cell = dof_handler.begin_active(); + cell->set_active_fe_index(1); + cell++; + cell->set_active_fe_index(1); + cell++; + cell->set_active_fe_index(0); + cell++; + cell->set_active_fe_index(0); + + + dof_handler.distribute_dofs (fe_collection); + + // Init solution + Vector solution(dof_handler.n_dofs()); + solution = 1.0; + + + SolutionTransfer<2, Vector, hp::DoFHandler<2> > solultion_trans(dof_handler); + solultion_trans.prepare_for_coarsening_and_refinement(solution); + + triangulation.execute_coarsening_and_refinement (); + dof_handler.distribute_dofs (fe_collection); + + Vector new_solution(dof_handler.n_dofs()); + solultion_trans.interpolate(solution, new_solution); + + hp::QCollection<2> q; + q.push_back(QMidpoint<2>()); + q.push_back(QMidpoint<2>()); + hp::FEValues<2> x_fe_values (fe_collection, q, update_gradients); + for (typename hp::DoFHandler<2>::active_cell_iterator cell = dof_handler.begin_active(); + cell != dof_handler.end(); ++cell) + { + x_fe_values.reinit (cell); + std::vector > > + derivatives (q[0].size(), std::vector >(cell->get_fe().n_components())); + + x_fe_values.get_present_fe_values().get_function_gradients (new_solution, + derivatives); + } + + // we are good if we made it to here + deallog << "OK" << std::endl; +} + + + diff --git a/tests/hp/do_function_derivatives_01.output b/tests/hp/do_function_derivatives_01.output new file mode 100644 index 0000000000..0fd8fc12f0 --- /dev/null +++ b/tests/hp/do_function_derivatives_01.output @@ -0,0 +1,2 @@ + +DEAL::OK