FiniteElementBase<dim>::component_to_system_index (const unsigned int component,
const unsigned int component_index) const
{
- Assert(component<n_components(),
- ExcIndexRange(component, 0, n_components()));
+ Assert(component<this->n_components(),
+ ExcIndexRange(component, 0, this->n_components()));
Assert(component_index<component_to_system_table[component].size(),
ExcIndexRange(component_index, 0,
component_to_system_table[component].size()));
FiniteElementBase<dim>::face_component_to_system_index (const unsigned int component,
const unsigned int component_index) const
{
- Assert(component<n_components(),
- ExcIndexRange(component, 0, n_components()));
+ Assert(component<this->n_components(),
+ ExcIndexRange(component, 0, this->n_components()));
Assert(component_index<face_component_to_system_table[component].size(),
ExcIndexRange(component_index, 0,
face_component_to_system_table[component].size()));
bool
FiniteElementBase<dim>::restriction_is_additive (const unsigned int component) const
{
- Assert(component<n_components(),
- ExcIndexRange(component, 0, n_components()));
+ Assert(component<this->n_components(),
+ ExcIndexRange(component, 0, this->n_components()));
return restriction_is_additive_flags[component];
}
const std::vector<bool> &
FiniteElementBase<dim>::get_nonzero_components (const unsigned int i) const
{
- Assert (i < dofs_per_cell, ExcIndexRange (i, 0, dofs_per_cell));
+ Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
return nonzero_components[i];
};
unsigned int
FiniteElementBase<dim>::n_nonzero_components (const unsigned int i) const
{
- Assert (i < dofs_per_cell, ExcIndexRange (i, 0, dofs_per_cell));
+ Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
return n_nonzero_components_table[i];
};
bool
FiniteElementBase<dim>::is_primitive (const unsigned int i) const
{
- Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, dofs_per_cell));
+ Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
// return primitivity of a shape
// function by checking whether it
// question to which vector
// component the call of this
// function refers
- return this->shape_values(shape_function_to_row_table[i], j);
+ return this->shape_values(this->shape_function_to_row_table[i], j);
}
// shape function in the arrays
// we index presently:
const unsigned int
- row = (shape_function_to_row_table[i]
+ row = (this->shape_function_to_row_table[i]
+
std::count (fe->get_nonzero_components(i).begin(),
fe->get_nonzero_components(i).begin()+component,
Assert (fe->is_primitive (i),
ExcShapeFunctionNotPrimitive(i));
Assert (i<this->shape_gradients.size(),
- ExcIndexRange (i, 0, shape_gradients.size()));
- Assert (j<shape_gradients[i].size(),
- ExcIndexRange (j, 0, shape_gradients[i].size()));
+ ExcIndexRange (i, 0, this->shape_gradients.size()));
+ Assert (j<this->shape_gradients[i].size(),
+ ExcIndexRange (j, 0, this->shape_gradients[i].size()));
// if the entire FE is primitive,
// then we can take a short-cut:
// question to which vector
// component the call of this
// function refers
- return this->shape_gradients[shape_function_to_row_table[i]][j];
+ return this->shape_gradients[this->shape_function_to_row_table[i]][j];
};
// shape function in the arrays
// we index presently:
const unsigned int
- row = (shape_function_to_row_table[i]
+ row = (this->shape_function_to_row_table[i]
+
std::count (fe->get_nonzero_components(i).begin(),
fe->get_nonzero_components(i).begin()+component,
Assert (fe->is_primitive (i),
ExcShapeFunctionNotPrimitive(i));
Assert (i<this->shape_2nd_derivatives.size(),
- ExcIndexRange (i, 0, shape_2nd_derivatives.size()));
+ ExcIndexRange (i, 0, this->shape_2nd_derivatives.size()));
Assert (j<this->shape_2nd_derivatives[i].size(),
- ExcIndexRange (j, 0, shape_2nd_derivatives[i].size()));
+ ExcIndexRange (j, 0, this->shape_2nd_derivatives[i].size()));
// if the entire FE is primitive,
// then we can take a short-cut:
// question to which vector
// component the call of this
// function refers
- return this->shape_2nd_derivatives[shape_function_to_row_table[i]][j];
+ return this->shape_2nd_derivatives[this->shape_function_to_row_table[i]][j];
}
// shape function in the arrays
// we index presently:
const unsigned int
- row = (shape_function_to_row_table[i]
+ row = (this->shape_function_to_row_table[i]
+
std::count (fe->get_nonzero_components(i).begin(),
fe->get_nonzero_components(i).begin()+component,
const Point<dim> &
FEFaceValuesBase<dim>::normal_vector (const unsigned int i) const
{
- Assert (i<this->normal_vectors.size(), ExcIndexRange(i, 0, normal_vectors.size()));
+ Assert (i<this->normal_vectors.size(), ExcIndexRange(i, 0, this->normal_vectors.size()));
Assert (this->update_flags & update_normal_vectors,
FEValuesBase<dim>::ExcAccessToUninitializedField());
bool
TriaObjectAccessor<celldim,dim>::used () const
{
- Assert (this->state() == IteratorState::valid, ExcDereferenceInvalidObject());
+ Assert (this->state() == IteratorState::valid,
+ typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
return this->tria->levels[this->present_level]->hexes.used[this->present_index];
};
bool
TriaObjectAccessor<celldim,dim>::user_flag_set () const
{
- Assert (this->used(), ExcCellNotUsed());
+ Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
return this->tria->levels[this->present_level]->hexes.user_flags[this->present_index];
};
void
TriaObjectAccessor<celldim,dim>::set_user_flag () const
{
- Assert (this->used(), ExcCellNotUsed());
+ Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
this->tria->levels[this->present_level]->hexes.user_flags[this->present_index] = true;
};
inline
void TriaObjectAccessor<celldim,dim>::clear_user_flag () const
{
- Assert (this->used(), ExcCellNotUsed());
+ Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
this->tria->levels[this->present_level]->hexes.user_flags[this->present_index] = false;
};
TriaIterator<dim,TriaObjectAccessor<1,dim> >
TriaObjectAccessor<celldim,dim>::line (const unsigned int i) const
{
- Assert (this->used(), ExcCellNotUsed());
+ Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
Assert (i < GeometryInfo<celldim>::lines_per_cell,
ExcIndexRange(i,0,GeometryInfo<celldim>::lines_per_cell));
TriaIterator<dim,TriaObjectAccessor<2,dim> >
TriaObjectAccessor<celldim,dim>::quad (const unsigned int i) const
{
- Assert (this->used(), ExcCellNotUsed());
+ Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
Assert (i < GeometryInfo<celldim>::quads_per_cell,
ExcIndexRange(i,0,GeometryInfo<celldim>::quads_per_cell));
return
q (this->tria, this->present_level+1, child_index (i));
Assert ((q.state() == IteratorState::past_the_end) || q->used(),
- ExcUnusedCellAsChild());
+ typename TriaAccessor<dim>::ExcUnusedCellAsChild());
return q;
};
// state==IteratorState::past_the_end, and will then
// throw the exception!
if (this->state() != IteratorState::past_the_end)
- Assert (this->accessor.used() && accessor.has_children()==false,
+ Assert (this->accessor.used() && this->accessor.has_children()==false,
ExcAssignmentOfInactiveObject());
#endif
return *this;
// and enough room was reserved
Assert (this->dof_handler->selected_fe != 0, DoFAccessor<dim>::ExcInvalidObject());
Assert (i<this->dof_handler->selected_fe->dofs_per_line,
- ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_line));
+ ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_line));
this->dof_handler->levels[this->present_level]
->line_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_line+i] = index;
typename BaseClass::ExcInvalidObject());
Assert (vertex<2, ExcIndexRange (i,0,2));
Assert (i<this->dof_handler->selected_fe->dofs_per_vertex,
- ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_vertex));
+ ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_vertex));
const unsigned int dof_number = (this->vertex_index(vertex) *
this->dof_handler->selected_fe->dofs_per_vertex +
Assert (this->dof_handler->selected_fe != 0,
typename BaseClass::ExcInvalidObject());
Assert (local_source.size() == (2*this->dof_handler->get_fe().dofs_per_vertex +
- dof_handler->get_fe().dofs_per_line),
+ this->dof_handler->get_fe().dofs_per_line),
typename BaseClass::ExcVectorDoesNotMatch());
Assert (this->dof_handler->n_dofs() == global_destination.size(),
typename BaseClass::ExcVectorDoesNotMatch());
Assert (this->dof_handler->selected_fe != 0,
typename BaseClass::ExcInvalidObject());
Assert (local_source.m() == (2*this->dof_handler->get_fe().dofs_per_vertex +
- dof_handler->get_fe().dofs_per_line),
+ this->dof_handler->get_fe().dofs_per_line),
typename BaseClass::ExcVectorDoesNotMatch());
Assert (local_source.m() == local_source.n(),
typename BaseClass::ExcMatrixDoesNotMatch());
Assert (this->dof_handler->selected_fe != 0,
typename DoFAccessor<dim>::ExcInvalidObject());
Assert (i<this->dof_handler->selected_fe->dofs_per_quad,
- ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_quad));
+ ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_quad));
this->dof_handler->levels[this->present_level]
->quad_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_quad+i] = index;
typename DoFAccessor<dim>::ExcInvalidObject());
Assert (vertex<4, ExcIndexRange (i,0,4));
Assert (i<this->dof_handler->selected_fe->dofs_per_vertex,
- ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_vertex));
+ ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_vertex));
const unsigned int dof_number = (this->vertex_index(vertex) *
this->dof_handler->selected_fe->dofs_per_vertex +
Assert (this->dof_handler->selected_fe != 0,
typename DoFAccessor<dim>::ExcInvalidObject());
Assert (local_source.size() == (4*this->dof_handler->get_fe().dofs_per_vertex +
- 4*dof_handler->get_fe().dofs_per_line +
- dof_handler->get_fe().dofs_per_quad),
+ 4*this->dof_handler->get_fe().dofs_per_line +
+ this->dof_handler->get_fe().dofs_per_quad),
typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
Assert (this->dof_handler->n_dofs() == global_destination.size(),
typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
Assert (this->dof_handler->selected_fe != 0,
typename DoFAccessor<dim>::ExcInvalidObject());
Assert (local_source.m() == (4*this->dof_handler->get_fe().dofs_per_vertex +
- 4*dof_handler->get_fe().dofs_per_line +
- dof_handler->get_fe().dofs_per_quad),
+ 4*this->dof_handler->get_fe().dofs_per_line +
+ this->dof_handler->get_fe().dofs_per_quad),
typename DoFAccessor<dim>::ExcMatrixDoesNotMatch());
Assert (local_source.m() == local_source.n(),
typename DoFAccessor<dim>::ExcMatrixDoesNotMatch());
Assert (this->dof_handler->selected_fe != 0,
typename DoFAccessor<dim>::ExcInvalidObject());
Assert (i<this->dof_handler->selected_fe->dofs_per_hex,
- ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_hex));
+ ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_hex));
this->dof_handler->levels[this->present_level]
->hex_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_hex+i] = index;
Assert (vertex<8,
ExcIndexRange (i,0,8));
Assert (i<this->dof_handler->selected_fe->dofs_per_vertex,
- ExcIndexRange (i, 0, dof_handler->selected_fe->dofs_per_vertex));
+ ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_vertex));
const unsigned int dof_number = (this->vertex_index(vertex) *
this->dof_handler->selected_fe->dofs_per_vertex +
Assert (this->dof_handler->selected_fe != 0,
typename DoFAccessor<dim>::ExcInvalidObject());
Assert (local_source.size() == (8*this->dof_handler->get_fe().dofs_per_vertex +
- 12*dof_handler->get_fe().dofs_per_line +
- 6*dof_handler->get_fe().dofs_per_quad +
- dof_handler->get_fe().dofs_per_hex),
+ 12*this->dof_handler->get_fe().dofs_per_line +
+ 6*this->dof_handler->get_fe().dofs_per_quad +
+ this->dof_handler->get_fe().dofs_per_hex),
typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
Assert (this->dof_handler->n_dofs() == global_destination.size(),
typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
Assert (this->dof_handler->selected_fe != 0,
typename DoFAccessor<dim>::ExcInvalidObject());
Assert (local_source.m() == (8*this->dof_handler->get_fe().dofs_per_vertex +
- 12*dof_handler->get_fe().dofs_per_line +
- 6*dof_handler->get_fe().dofs_per_quad +
- dof_handler->get_fe().dofs_per_hex),
+ 12*this->dof_handler->get_fe().dofs_per_line +
+ 6*this->dof_handler->get_fe().dofs_per_quad +
+ this->dof_handler->get_fe().dofs_per_hex),
typename DoFAccessor<dim>::ExcMatrixDoesNotMatch());
Assert (local_source.m() == local_source.n(),
typename DoFAccessor<dim>::ExcMatrixDoesNotMatch());
const unsigned int dofs_per_vertex = this->dof_handler->get_fe().dofs_per_vertex,
dofs_per_line = this->dof_handler->get_fe().dofs_per_line,
- dofs_per_quad = dof_handler->get_fe().dofs_per_quad,
- dofs_per_hex = dof_handler->get_fe().dofs_per_hex;
+ dofs_per_quad = this->dof_handler->get_fe().dofs_per_quad,
+ dofs_per_hex = this->dof_handler->get_fe().dofs_per_hex;
typename Vector<number>::iterator next_local_value = local_values.begin();
for (unsigned int vertex=0; vertex<GeometryInfo<3>::vertices_per_cell; ++vertex)
for (unsigned int d=0; d<dofs_per_vertex; ++d)
const unsigned int dofs_per_vertex = this->dof_handler->get_fe().dofs_per_vertex,
dofs_per_line = this->dof_handler->get_fe().dofs_per_line,
- dofs_per_quad = dof_handler->get_fe().dofs_per_quad,
- dofs_per_hex = dof_handler->get_fe().dofs_per_hex;
+ dofs_per_quad = this->dof_handler->get_fe().dofs_per_quad,
+ dofs_per_hex = this->dof_handler->get_fe().dofs_per_hex;
typename Vector<number>::const_iterator next_local_value=local_values.begin();
for (unsigned int vertex=0; vertex<GeometryInfo<dim>::vertices_per_cell; ++vertex)
for (unsigned int d=0; d<dofs_per_vertex; ++d)
for (unsigned int i=0; i<dofs_per_cell; ++i)
{
const unsigned int component
- = dof_handler->get_fe().system_to_component_index(i).first;
+ = this->dof_handler->get_fe().system_to_component_index(i).first;
- if (dof_handler->get_fe().restriction_is_additive(component))
+ if (this->dof_handler->get_fe().restriction_is_additive(component))
interpolated_values(i) += tmp2(i);
else
if (tmp2(i) != 0)