// ---------------------------------------------------------------------
//
-// Copyright (C) 2005 - 2015 by the deal.II authors
+// Copyright (C) 2005 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog.threshold_double(1.e-10);
const unsigned int dim = 2;
+
+ Data::SetUp<Data::Exercise_2_3<dim>,dim> setup;
+ const Point<dim> evaluation_point (0.75, 0.75);
+ DualFunctional::PointValueEvaluation<dim> eval(evaluation_point);
+
Framework<dim>::ProblemDescription descriptor;
descriptor.refinement_criterion
descriptor.primal_fe_degree = 1;
descriptor.dual_fe_degree = 2;
- descriptor.data = new Data::SetUp<Data::Exercise_2_3<dim>,dim> ();
-
- const Point<dim> evaluation_point (0.75, 0.75);
- descriptor.dual_functional
- = new DualFunctional::PointValueEvaluation<dim> (evaluation_point);
+ descriptor.data = &setup;
+ descriptor.dual_functional = &eval;
Evaluation::PointValueEvaluation<dim>
postprocessor1 (evaluation_point);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2012 - 2015 by the deal.II authors
+// Copyright (C) 2012 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
std::string fluid_fe_name = "FESystem[FE_Nothing()^2-FE_Nothing()^2-FE_Q(2)^2-FE_Q(1)-FE_Q(2)^2]";
hp::FECollection<dim> fe_collection;
- FiniteElement<dim> *solid_fe = FETools::get_fe_by_name<dim, dim>(solid_fe_name);
- FiniteElement<dim> *fluid_fe = FETools::get_fe_by_name<dim, dim>(fluid_fe_name);
+ std_cxx11::unique_ptr<FiniteElement<dim> > solid_fe (FETools::get_fe_by_name<dim, dim>(solid_fe_name));
+ std_cxx11::unique_ptr<FiniteElement<dim> > fluid_fe (FETools::get_fe_by_name<dim, dim>(fluid_fe_name));
deallog << "Solid FE Space: " << solid_fe->get_name() << std::endl;
deallog << "Fluid/Mesh FE Space: " << fluid_fe->get_name() << std::endl;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2015 by the deal.II authors
+// Copyright (C) 2003 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
return;
}
deallog << c->description() << std::endl;
+ delete c;
}