#include <fe/fe.h>
#include <fe/mapping.h>
#include <fe/fe_dgp.h>
+#include <fe/mapping_q1.h>
#include <fe/fe_values.h>
#ifdef HAVE_STD_STRINGSTREAM
}
if (flags & update_second_derivatives)
- this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+ this->compute_2nd (mapping, cell,
+ internal::DataSetDescriptor<dim>::cell().offset(),
+ mapping_data, fe_data, data);
}
// offset determines which data set
// to take (all data sets for all
// faces are stored contiguously)
- const unsigned int offset = face * quadrature.n_quadrature_points;
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ face (cell, face,
+ quadrature.n_quadrature_points)).offset();
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
// offset determines which data set
// to take (all data sets for all
// sub-faces are stored contiguously)
- const unsigned int offset = (face * GeometryInfo<dim>::subfaces_per_face + subface)
- * quadrature.n_quadrature_points;
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ sub_face (cell, face, subface,
+ quadrature.n_quadrature_points)).offset();
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
#include <grid/tria_iterator.h>
#include <dofs/dof_accessor.h>
#include <fe/fe.h>
+#include <fe/mapping_q1.h>
#include <fe/mapping.h>
#include <fe/fe_dgq.h>
#include <fe/fe_values.h>
}
if (flags & update_second_derivatives)
- this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+ this->compute_2nd (mapping, cell,
+ internal::DataSetDescriptor<dim>::cell().offset(),
+ mapping_data, fe_data, data);
}
// offset determines which data set
// to take (all data sets for all
// faces are stored contiguously)
- const unsigned int offset = face * quadrature.n_quadrature_points;
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ face (cell, face,
+ quadrature.n_quadrature_points)).offset();
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
// offset determines which data set
// to take (all data sets for all
// sub-faces are stored contiguously)
- const unsigned int offset = (face * GeometryInfo<dim>::subfaces_per_face + subface)
- * quadrature.n_quadrature_points;
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ sub_face (cell, face, subface,
+ quadrature.n_quadrature_points)).offset();
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
#include <dofs/dof_accessor.h>
#include <fe/fe.h>
#include <fe/mapping.h>
+#include <fe/mapping_q1.h>
#include <fe/fe_q.h>
#include <fe/fe_values.h>
}
if (flags & update_second_derivatives)
- this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+ this->compute_2nd (mapping, cell,
+ internal::DataSetDescriptor<dim>::cell().offset(),
+ mapping_data, fe_data, data);
}
// offset determines which data set
// to take (all data sets for all
// faces are stored contiguously)
- const unsigned int offset = face * quadrature.n_quadrature_points;
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ face (cell, face,
+ quadrature.n_quadrature_points)).offset();
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
// offset determines which data set
// to take (all data sets for all
// sub-faces are stored contiguously)
- const unsigned int offset = ((face * GeometryInfo<dim>::subfaces_per_face + subface)
- * quadrature.n_quadrature_points);
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ sub_face (cell, face, subface,
+ quadrature.n_quadrature_points)).offset();
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
#include <dofs/dof_accessor.h>
#include <fe/fe.h>
#include <fe/mapping.h>
+#include <fe/mapping_q1.h>
#include <fe/fe_q_hierarchical.h>
#include <fe/fe_values.h>
}
if (flags & update_second_derivatives)
- this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+ this->compute_2nd (mapping, cell,
+ internal::DataSetDescriptor<dim>::cell().offset(),
+ mapping_data, fe_data, data);
}
// offset determines which data set
// to take (all data sets for all
// faces are stored contiguously)
- const unsigned int offset = face * quadrature.n_quadrature_points;
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ face (cell, face,
+ quadrature.n_quadrature_points)).offset();
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
// offset determines which data set
// to take (all data sets for all
// sub-faces are stored contiguously)
- const unsigned int offset = ((face * GeometryInfo<dim>::subfaces_per_face + subface)
- * quadrature.n_quadrature_points);
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ sub_face (cell, face, subface,
+ quadrature.n_quadrature_points)).offset();
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
#include <dofs/dof_accessor.h>
#include <fe/fe.h>
#include <fe/mapping.h>
+#include <fe/mapping_q1.h>
#include <fe/fe_raviart_thomas.h>
#include <fe/fe_values.h>
}
if (flags & update_second_derivatives)
- this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
+ this->compute_2nd (mapping, cell,
+ internal::DataSetDescriptor<dim>::cell().offset(),
+ mapping_data, fe_data, data);
}
// offset determines which data set
// to take (all data sets for all
// faces are stored contiguously)
- const unsigned int offset = face * quadrature.n_quadrature_points;
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ face (cell, face,
+ quadrature.n_quadrature_points)).offset();
// get the flags indicating the
// fields that have to be filled
// offset determines which data set
// to take (all data sets for all
// faces are stored contiguously)
- const unsigned int offset = ((face * GeometryInfo<dim>::subfaces_per_face + subface)
- * quadrature.n_quadrature_points);
+ const unsigned int offset
+ = (internal::DataSetDescriptor<dim>::
+ sub_face (cell, face, subface,
+ quadrature.n_quadrature_points)).offset();
// get the flags indicating the
// fields that have to be filled