};
template <int dim>
- double RightHandSide<dim>::value (const Point<dim> &p,
+ double RightHandSide<dim>::value (const Point<dim> &,
const unsigned int component) const
{
Assert (component == 0, ExcNotImplemented());
};
template <int dim>
- double BoundaryValues<dim>::value (const Point<dim> &p,
+ double BoundaryValues<dim>::value (const Point<dim> &,
const unsigned int component) const
{
Assert (component == 0, ExcNotImplemented());
Vector<double> soln(solution_n.size());
for (unsigned int i = 0; i < soln.size(); ++i)
soln(i) = solution_n(i);
- MappingQEulerian<dim> q_mapping(degree, soln, dof_handler_ref);
+ MappingQEulerian<dim> q_mapping(degree, dof_handler_ref, soln);
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
template <int dim>
std::pair<unsigned int, Quadrature<dim> >
LaplaceProblem<dim>::compute_quadrature (const Quadrature<dim> &plain_quadrature,
- const typename hp::DoFHandler<dim>::active_cell_iterator &cell,
- const std::vector<double> &level_set_values )
+ const typename hp::DoFHandler<dim>::active_cell_iterator &/*cell*/,
+ const std::vector<double> &level_set_values)
{
unsigned int type = 0;
// ++++, ---- type 2: -+++, +-++, ++-+, +++-, +---, -+--, --+-, ---+ type
// 3: +--+, ++--, +-+-, -++-, --++, -+-+
- if ( sign_ls[0]==sign_ls[1] & sign_ls[0]==sign_ls[2] & sign_ls[0]==sign_ls[3] ) type =1;
- else if ( sign_ls[0]*sign_ls[1]*sign_ls[2]*sign_ls[3] < 0 ) type = 2;
- else type = 3;
+ if ( sign_ls[0]==sign_ls[1] &&
+ sign_ls[0]==sign_ls[2] &&
+ sign_ls[0]==sign_ls[3] )
+ type = 1;
+ else if ( sign_ls[0]*sign_ls[1]*sign_ls[2]*sign_ls[3] < 0 )
+ type = 2;
+ else
+ type = 3;
unsigned int Pos = 100;