* cases where <code>solution_filename == mesh_filename</code>, and
* <code>dim==spacedim</code>.
*/
- XDMFEntry(const std::string filename,
+ XDMFEntry(const std::string &filename,
const double time,
const unsigned int nodes,
const unsigned int cells,
* Simplified constructor that calls the complete constructor for
* cases where <code>dim==spacedim</code>.
*/
- XDMFEntry(const std::string mesh_filename,
- const std::string solution_filename,
+ XDMFEntry(const std::string &mesh_filename,
+ const std::string &solution_filename,
const double time,
const unsigned int nodes,
const unsigned int cells,
/**
* Constructor that sets all members to provided parameters.
*/
- XDMFEntry(const std::string mesh_filename,
- const std::string solution_filename,
+ XDMFEntry(const std::string &mesh_filename,
+ const std::string &solution_filename,
const double time,
const unsigned int nodes,
const unsigned int cells,
*/
MappingFEField (const DoFHandlerType &euler_dof_handler,
const VectorType &euler_vector,
- const ComponentMask mask = ComponentMask());
+ const ComponentMask &mask = ComponentMask());
/**
* Copy constructor.
* Constructor.
*/
InternalData(const FiniteElement<dim,spacedim> &fe,
- const ComponentMask mask);
+ const ComponentMask &mask);
/**
* Shape function at quadrature point. Shape functions are in tensor
* have to be evaluated to true and state if the iterator must be locally
* owned.
*/
- MaterialIdEqualTo (const std::set<types::material_id> material_ids,
+ MaterialIdEqualTo (const std::set<types::material_id> &material_ids,
const bool only_locally_owned = false);
/**
* shall have to be evaluated to true and state if the iterator must be
* locally owned.
*/
- ActiveFEIndexEqualTo (const std::set<unsigned int> active_fe_indices,
+ ActiveFEIndexEqualTo (const std::set<unsigned int> &active_fe_indices,
const bool only_locally_owned = false);
/**
inline
- MaterialIdEqualTo::MaterialIdEqualTo (const std::set<types::material_id> material_ids,
+ MaterialIdEqualTo::MaterialIdEqualTo (const std::set<types::material_id> &material_ids,
const bool only_locally_owned)
:
material_ids (material_ids),
inline
- ActiveFEIndexEqualTo::ActiveFEIndexEqualTo (const std::set<unsigned int> active_fe_indices,
+ ActiveFEIndexEqualTo::ActiveFEIndexEqualTo (const std::set<unsigned int> &active_fe_indices,
const bool only_locally_owned)
:
active_fe_indices (active_fe_indices),
*/
void import(const distributed::Vector<Number> &vec,
VectorOperation::values operation,
- std::shared_ptr<const CommunicationPatternBase> communication_pattern =
+ const std::shared_ptr<const CommunicationPatternBase> &communication_pattern =
std::shared_ptr<const CommunicationPatternBase> ());
#ifdef DEAL_II_WITH_PETSC
*/
void import(const PETScWrappers::MPI::Vector &petsc_vec,
VectorOperation::values operation,
- std::shared_ptr<const CommunicationPatternBase> communication_pattern =
+ const std::shared_ptr<const CommunicationPatternBase> &communication_pattern =
std::shared_ptr<const CommunicationPatternBase> ());
#endif
const IndexSet &locally_owned_elements,
VectorOperation::values operation,
const MPI_Comm &mpi_comm,
- std::shared_ptr<const CommunicationPatternBase> communication_pattern);
+ const std::shared_ptr<const CommunicationPatternBase> &communication_pattern);
#endif
/**
void
ReadWriteVector<Number>::import(const distributed::Vector<Number> &vec,
VectorOperation::values operation,
- std::shared_ptr<const CommunicationPatternBase> communication_pattern)
+ const std::shared_ptr<const CommunicationPatternBase> &communication_pattern)
{
// If no communication pattern is given, create one. Otherwise, use the
// given one.
void
ReadWriteVector<Number>::import(const PETScWrappers::MPI::Vector &petsc_vec,
VectorOperation::values /*operation*/,
- std::shared_ptr<const CommunicationPatternBase> /*communication_pattern*/)
+ const std::shared_ptr<const CommunicationPatternBase> & /*communication_pattern*/)
{
//TODO: this works only if no communication is needed.
Assert(petsc_vec.locally_owned_elements() == stored_elements,
const IndexSet &source_elements,
VectorOperation::values operation,
const MPI_Comm &mpi_comm,
- std::shared_ptr<const CommunicationPatternBase> communication_pattern)
+ const std::shared_ptr<const CommunicationPatternBase> &communication_pattern)
{
std::shared_ptr<const EpetraWrappers::CommunicationPattern> epetra_comm_pattern;
* last step command. Numbers with less digits are filled with
* zeros from the left.
*/
- DoFOutputOperator (const std::string filename_base = std::string("output"),
+ DoFOutputOperator (const std::string &filename_base = std::string("output"),
const unsigned int digits = 3);
void parse_parameters(ParameterHandler ¶m);
{
template <typename VectorType, int dim, int spacedim>
DoFOutputOperator<VectorType, dim, spacedim>::DoFOutputOperator (
- const std::string filename_base,
+ const std::string &filename_base,
const unsigned int digits)
:
filename_base(filename_base),
const types::subdomain_id subdomain_id,
const types::material_id material_id,
const typename FunctionMap<spacedim>::type *neumann_bc,
- const ComponentMask component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients);
/**
const types::subdomain_id subdomain_id,
const types::material_id material_id,
const typename FunctionMap<spacedim>::type *neumann_bc,
- const ComponentMask component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients)
:
finite_element (fe),
columns[rate_key].flag = 1;
set_precision(rate_key, 2);
- std::string superkey = data_column_key;
+ const std::string &superkey = data_column_key;
if (!supercolumns.count(superkey))
{
add_column_to_supercolumn(data_column_key, superkey);
set_precision(rate_key, 2);
// set the superkey equal to the key
- std::string superkey=data_column_key;
+ const std::string &superkey=data_column_key;
// and set the tex caption of the supercolumn to the tex caption of the
// data_column.
if (!supercolumns.count(superkey))
-XDMFEntry::XDMFEntry(const std::string filename,
+XDMFEntry::XDMFEntry(const std::string &filename,
const double time,
const unsigned int nodes,
const unsigned int cells,
-XDMFEntry::XDMFEntry(const std::string mesh_filename,
- const std::string solution_filename,
+XDMFEntry::XDMFEntry(const std::string &mesh_filename,
+ const std::string &solution_filename,
const double time,
const unsigned int nodes,
const unsigned int cells,
-XDMFEntry::XDMFEntry(const std::string mesh_filename,
- const std::string solution_filename,
+XDMFEntry::XDMFEntry(const std::string &mesh_filename,
+ const std::string &solution_filename,
const double time,
const unsigned int nodes,
const unsigned int cells,
template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData::InternalData
(const FiniteElement<dim,spacedim> &fe,
- const ComponentMask mask)
+ const ComponentMask &mask)
:
n_shape_functions (fe.dofs_per_cell),
mask (mask),
MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::MappingFEField
(const DoFHandlerType &euler_dof_handler,
const VectorType &euler_vector,
- const ComponentMask mask)
+ const ComponentMask &mask)
:
euler_vector(&euler_vector),
fe(&euler_dof_handler.get_fe()),
const double tolerance)
{
TopoDS_Edge out_shape;
- TopoDS_Shape edges = in_shape;
+ const TopoDS_Shape &edges = in_shape;
std::vector<Handle_Geom_BoundedCurve> intersections;
TopLoc_Location L;
Standard_Real First;