unsigned int ncells = compute_point_locations(points, cells, qpoints, maps);
hp::MappingCollection<dim> mapping_collection (mapping);
- hp::FECollection<dim> fe_collection (dh->get_fe_collection());
+ const hp::FECollection<dim> &fe_collection = dh->get_fe_collection();
hp::QCollection<dim> quadrature_collection;
// Create quadrature collection
for (unsigned int i=0; i<ncells; ++i)
unsigned int ncells = compute_point_locations(points, cells, qpoints, maps);
hp::MappingCollection<dim> mapping_collection (mapping);
- hp::FECollection<dim> fe_collection (dh->get_fe_collection());
+ const hp::FECollection<dim> &fe_collection = dh->get_fe_collection();
hp::QCollection<dim> quadrature_collection;
// Create quadrature collection
for (unsigned int i=0; i<ncells; ++i)
unsigned int ncells = compute_point_locations(points, cells, qpoints, maps);
hp::MappingCollection<dim> mapping_collection (mapping);
- hp::FECollection<dim> fe_collection (dh->get_fe_collection());
+ const hp::FECollection<dim> &fe_collection = dh->get_fe_collection();
hp::QCollection<dim> quadrature_collection;
// Create quadrature collection
for (unsigned int i=0; i<ncells; ++i)
Assert (component_mask.n_selected_components(dof.get_finite_element(0).n_components()) > 0,
ComponentMask::ExcNoComponentSelected());
- const hp::FECollection<dim,spacedim> fe (dof.get_fe_collection());
+ const hp::FECollection<dim,spacedim> &fe = dof.get_fe_collection();
const unsigned int n_components = fe.n_components();
const bool fe_is_system = (n_components != 1);
ExcDimensionMismatch(dof.get_finite_element(0).n_components(), iter->second->n_components) );
}
- const hp::FECollection<dim, spacedim>
- fe(dof.get_fe_collection());
+ const hp::FECollection<dim, spacedim> &fe = dof.get_fe_collection();
const unsigned int n_components = fe.n_components();
const bool fe_is_system = (n_components != 1);
// before we start with the loop over all cells create an hp::FEValues
// object that holds the interpolation points of all finite elements
// that may ever be in use
- dealii::hp::FECollection<dim,spacedim> finite_elements (dof.get_fe_collection());
+ const dealii::hp::FECollection<dim,spacedim> &finite_elements = dof.get_fe_collection();
dealii::hp::QCollection<dim-1> q_collection;
for (unsigned int f=0; f<finite_elements.size(); ++f)
{
// create FE and mapping collections for all elements in use by this
// DoFHandler
- hp::FECollection<dim,spacedim> fe_collection (dof_handler.get_fe_collection());
+ const hp::FECollection<dim,spacedim> &fe_collection = dof_handler.get_fe_collection();
hp::MappingCollection<dim,spacedim> mapping_collection;
for (unsigned int i=0; i<fe_collection.size(); ++i)
mapping_collection.push_back (mapping);
no_normal_flux_constraints,
mapping);
- hp::FECollection<dim,spacedim> fe_collection (dof_handler.get_fe_collection());
+ const hp::FECollection<dim,spacedim> &fe_collection = dof_handler.get_fe_collection();
hp::MappingCollection<dim,spacedim> mapping_collection;
for (unsigned int i=0; i<fe_collection.size(); ++i)
mapping_collection.push_back (mapping);
break;
}
- dealii::hp::FECollection<dim,spacedim> fe_collection (dof.get_fe_collection());
+ const dealii::hp::FECollection<dim,spacedim> &fe_collection = dof.get_fe_collection();
IDScratchData<dim,spacedim, Number> data(mapping, fe_collection, q, update_flags);
// loop over all cells
std::vector<std::pair<Point<DoFHandlerType::space_dimension>,unsigned int> > support_point_list
(n_dofs);
- const hp::FECollection<DoFHandlerType::dimension> fe_collection (dof.get_fe_collection());
+ const hp::FECollection<DoFHandlerType::dimension> &fe_collection = dof.get_fe_collection();
Assert (fe_collection[0].has_support_points(),
typename FiniteElement<DoFHandlerType::dimension>::ExcFEHasNoSupportPoints());
hp::QCollection<DoFHandlerType::dimension> quadrature_collection;
const ComponentMask &component_mask,
std::vector<unsigned char> &dofs_by_component)
{
- const dealii::hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension>
- fe_collection (dof.get_fe_collection());
+ const dealii::hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension> &
+ fe_collection = dof.get_fe_collection();
Assert (fe_collection.n_components() < 256, ExcNotImplemented());
Assert (dofs_by_component.size() == dof.n_locally_owned_dofs(),
ExcDimensionMismatch(dofs_by_component.size(),
get_block_association (const DoFHandlerType &dof,
std::vector<unsigned char> &dofs_by_block)
{
- const dealii::hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension>
- fe_collection (dof.get_fe_collection());
+ const dealii::hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension> &
+ fe_collection = dof.get_fe_collection();
Assert (fe_collection.n_components() < 256, ExcNotImplemented());
Assert (dofs_by_block.size() == dof.n_locally_owned_dofs(),
ExcDimensionMismatch(dofs_by_block.size(),
//
// TODO: We might be able to extend this also for elements which do not
// have the same constant modes, but that is messy...
- const dealii::hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension>
- fe_collection (dof_handler.get_fe_collection());
+ const dealii::hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension> &
+ fe_collection = dof_handler.get_fe_collection();
std::vector<Table<2,bool> > element_constant_modes;
std::vector<std::vector<std::pair<unsigned int, unsigned int> > >
constant_mode_to_component_translation(n_components);
{
std::vector<unsigned int> target_block = target_block_;
- const dealii::hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension>
- fe_collection (dof_handler.get_fe_collection());
+ const dealii::hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension> &
+ fe_collection = dof_handler.get_fe_collection();
Assert (fe_collection.size() < 256, ExcNotImplemented());
for (unsigned int this_fe=0; this_fe<fe_collection.size(); ++this_fe)
const unsigned int dim = DoFHandlerType::dimension;
const unsigned int spacedim = DoFHandlerType::space_dimension;
- hp::FECollection<dim, spacedim> fe_collection(dof_handler.get_fe_collection());
+ const hp::FECollection<dim, spacedim> &fe_collection = dof_handler.get_fe_collection();
hp::QCollection<dim> q_coll_dummy;
for (unsigned int fe_index = 0; fe_index < fe_collection.size(); ++fe_index)
"associated DoF handler objects, asking for any subdomain other "
"than the locally owned one does not make sense."));
- const hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension> fe_collection (dof.get_fe_collection());
+ const hp::FECollection<DoFHandlerType::dimension,DoFHandlerType::space_dimension> &fe_collection = dof.get_fe_collection();
const std::vector<Table<2,Coupling> > dof_mask //(fe_collection.size())
= dof_couplings_from_component_couplings (fe_collection,
// collection of which we do a
// shallow copy instead
const hp::QCollection<dim> q_collection (patch_points);
- const hp::FECollection<dim> fe_collection(dof_handler->get_fe_collection());
+ const hp::FECollection<dim> &fe_collection = dof_handler->get_fe_collection();
hp::FEValues<dim> x_fe_patch_values (fe_collection, q_collection,
update_values);
// collection of which we do a
// shallow copy instead
const hp::QCollection<dim> q_collection (midpoint_rule);
- const hp::FECollection<dim> fe_collection(dof_handler.get_fe_collection());
+ const hp::FECollection<dim> &fe_collection = dof_handler.get_fe_collection();
const hp::MappingCollection<dim> mapping_collection (mapping);
hp::FEValues<dim> x_fe_midpoint_value (mapping_collection, fe_collection,
const QGauss<0> face_quadrature(1);
const hp::QCollection<0> q_face_collection(face_quadrature);
- const hp::FECollection<1,spacedim> fe (dof_handler.get_fe_collection());
+ const hp::FECollection<1,spacedim> &fe = dof_handler.get_fe_collection();
hp::MappingCollection<1,spacedim> mapping_collection;
mapping_collection.push_back (mapping);