vector<double>::iterator next_local_value=local_values.begin();
for (unsigned int vertex=0; vertex<2; ++vertex)
for (unsigned int d=0; d<dofs_per_vertex; ++d)
- *next_lcoal_value++ = values(vertex_dof_index(vertex,d));
+ *next_local_value++ = values(vertex_dof_index(vertex,d));
for (unsigned int d=0; d<dofs_per_line; ++d)
*next_local_value++ = values(dof_index(d));
};
template <>
void FELinearMapping<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
- const vector<Point<1> > &unit_points,
- vector<dFMatrix> &jacobians,
- const bool compute_jacobians,
- vector<Point<1> > &support_points,
- const bool compute_support_points,
- vector<Point<1> > &q_points,
- const bool compute_q_points,
- const dFMatrix &shape_values_transform,
+ const vector<Point<1> > &unit_points,
+ vector<Tensor<2,1> > &jacobians,
+ const bool compute_jacobians,
+ vector<Tensor<3,1> > &jacobians_grad,
+ const bool compute_jacobians_grad,
+ vector<Point<1> > &support_points,
+ const bool compute_support_points,
+ vector<Point<1> > &q_points,
+ const bool compute_q_points,
+ const dFMatrix &shape_values_transform,
const vector<vector<Tensor<1,1> > > &shape_gradients_transform,
const Boundary<1> &boundary) const {
// simply pass down
FiniteElement<1>::fill_fe_values (cell, unit_points,
jacobians, compute_jacobians,
+ jacobians_grad, compute_jacobians_grad,
support_points, compute_support_points,
q_points, compute_q_points,
shape_values_transform, shape_gradients_transform,
template <>
FiniteElementData<1>
FESystem<1>::multiply_dof_numbers (const FiniteElementData<1> &fe_data,
- const unsigned int &N) {
+ const unsigned int N) {
return FiniteElementData<1> (fe_data.dofs_per_vertex * N,
fe_data.dofs_per_line * N,
fe_data.n_transform_functions);
template <>
FiniteElementData<2>
FESystem<2>::multiply_dof_numbers (const FiniteElementData<2> &fe_data,
- const unsigned int N) {
+ const unsigned int N) {
return FiniteElementData<2> (fe_data.dofs_per_vertex * N,
fe_data.dofs_per_line * N,
fe_data.dofs_per_quad * N,