term <code>2nd_derivatives</code> were removed in favor of those
with names containing <code>hessian</code>. Similarly, functions
with names including <code>function_grads</code> were removed in
- favor of those called <code>function_gradients</code>.
+ favor of those called <code>function_gradients</code>. Finally,
+ the <code>cell_normal_vector</code> functions were replaced by
+ <code>normal_vector</code> ones. In all cases, the new functions
+ have been around for a while.
<!-- ----------- GENERAL IMPROVEMENTS ----------------- -->
const std::vector<Tensor<1,dim> > &original,
MappingType mapping) const;
- /**
- * @deprecated Use normal_vector() instead.
- *
- * Return the outward normal vector to the cell at the <tt>i</tt>th
- * quadrature point. The length of the vector is normalized to one.
- */
- const Point<spacedim> &cell_normal_vector (const unsigned int i) const DEAL_II_DEPRECATED;
-
- /**
- * @deprecated Use get_normal_vectors() instead.
- *
- * Returns the vectors normal to the cell in each of the quadrature points.
- */
- const std::vector<Point<spacedim> > &get_cell_normal_vectors () const DEAL_II_DEPRECATED;
-
//@}
/// @name Extractors Methods to extract individual components
-template <int dim, int spacedim>
-inline
-const Point<spacedim> &
-FEValuesBase<dim,spacedim>::cell_normal_vector (const unsigned int i) const
-{
- return this->normal_vector(i);
-}
-
-
-
-
/*------------------------ Inline functions: FEValues ----------------------------*/
-template <int dim, int spacedim>
-const std::vector<Point<spacedim> > &
-FEValuesBase<dim,spacedim>::get_cell_normal_vectors () const
-{
- return this->get_normal_vectors ();
-}
-
-
template <int dim, int spacedim>
void
FEValuesBase<dim,spacedim>::transform (
FEValues<spacedim-1, spacedim>
fe_values_i (fe, quadrature_formula,
update_JxW_values |
- update_cell_normal_vectors |
+ update_normal_vectors |
update_quadrature_points ),
fe_values_j (fe, quadrature_formula,
update_JxW_values |
- update_cell_normal_vectors |
+ update_normal_vectors |
update_quadrature_points );
const unsigned int dofs_per_cell = fe.dofs_per_cell;
{
fe_values_i.reinit (cell_i);
- cell_normals_i = fe_values_i.get_cell_normal_vectors();
+ cell_normals_i = fe_values_i.get_normal_vectors();
cell_i->get_dof_indices (local_dof_indices_i);
// if (cell_i->index()%100==0)
for (cell_j=dof_handler.begin_active(); cell_j!=endc; ++cell_j)
{
fe_values_j.reinit (cell_j);
- cell_normals_j = fe_values_j.get_cell_normal_vectors();
+ cell_normals_j = fe_values_j.get_normal_vectors();
cell_j->get_dof_indices (local_dof_indices_j);
if (cell_j != cell_i)
q_iterated,
update_values |
update_gradients |
- update_cell_normal_vectors );
+ update_normal_vectors );
std::vector< Point<spacedim> > cell_normals(q_iterated.size());
std::vector< Point<spacedim> > cell_tangentials(q_iterated.size());
// std::cout<<std::endl;
- cell_normals = fe_values_q.get_cell_normal_vectors();
+ cell_normals = fe_values_q.get_normal_vectors();
for (unsigned int i=0; i<q_iterated.size(); ++i)
{
cell_tangentials[i][0] = cell_normals[i][1];
FEValues<dim,spacedim> fe_values (fe, q_midpoint,
update_values |
update_JxW_values |
- update_cell_normal_vectors |
+ update_normal_vectors |
update_gradients);
// finite elements used for the
DoFHandler<dim,spacedim> dof_handler_help (triangulation);
dof_handler_help.distribute_dofs (fe_help);
FEValues<dim,spacedim> fe_values_help (fe_help, q_midpoint,
- update_cell_normal_vectors);
+ update_normal_vectors);
deallog
<< "no. of cells "<< triangulation.n_cells() <<std::endl;
fe_values.reinit(cell);
cell-> get_dof_indices (local_dof_indices);
- cell_normals = fe_values.get_cell_normal_vectors();
+ cell_normals = fe_values.get_normal_vectors();
// The cell tangential is calculated
// in the midpoint of the cell. For
MappingQ1<dim-1,dim> mapping;
FE_Q<dim-1,dim> fe (1);
- FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_cell_normal_vectors);
+ FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_normal_vectors);
for (typename Triangulation<dim-1,dim>::active_cell_iterator
cell = boundary_mesh.begin_active(); cell != boundary_mesh.end();
for (unsigned int q=0; q<quadrature.size(); ++q)
deallog << " cell_normal[" << q << "] = "
- << fe_values.cell_normal_vector(q)
+ << fe_values.normal_vector(q)
<< std::endl;
}
}
MappingQ<dim-1,dim> mapping(2);
FE_Q<dim-1,dim> fe (1);
- FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_cell_normal_vectors);
+ FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_normal_vectors);
for (typename Triangulation<dim-1,dim>::active_cell_iterator
cell = boundary_mesh.begin_active(); cell != boundary_mesh.end();
for (unsigned int q=0; q<quadrature.size(); ++q)
deallog << " cell_normal[" << q << "] = "
- << fe_values.cell_normal_vector(q)
+ << fe_values.normal_vector(q)
<< std::endl;
}
}
FEValues<dim,spacedim> fe_values (dummy_fe, quadrature,
update_JxW_values |
- update_cell_normal_vectors |
+ update_normal_vectors |
update_quadrature_points);
dof_handler.distribute_dofs (dummy_fe);
for (; cell!=endc; ++cell)
{
fe_values.reinit (cell);
- const std::vector<Point<spacedim> > &cellnormals = fe_values.get_cell_normal_vectors();
+ const std::vector<Point<spacedim> > &cellnormals = fe_values.get_normal_vectors();
const std::vector<Point<spacedim> > &quad_points = fe_values.get_quadrature_points();
for (unsigned int i=0; i<fe_values.n_quadrature_points; ++i)