DEAL_II_NAMESPACE_OPEN
-namespace
+namespace internal
{
template <class VectorType>
typename VectorType::value_type
+ inline
get_vector_element (const VectorType &vector,
const types::global_dof_index cell_number)
{
}
+
IndexSet::value_type
+ inline
get_vector_element (const IndexSet &is,
const types::global_dof_index cell_number)
{
return (is.is_element(cell_number) ? 1 : 0);
}
-}
-namespace
-{
+
template <int dim, int spacedim>
inline
std::vector<unsigned int>
// variables from FEValuesBase, but they aren't initialized yet
// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = make_shape_function_to_row_table (fe);
+ = internal::make_shape_function_to_row_table (fe);
for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
{
// variables from FEValuesBase, but they aren't initialized yet
// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = make_shape_function_to_row_table (fe);
+ = internal::make_shape_function_to_row_table (fe);
for (unsigned int d=0; d<spacedim; ++d)
{
// variables from FEValuesBase, but they aren't initialized yet
// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = make_shape_function_to_row_table (fe);
+ = internal::make_shape_function_to_row_table (fe);
for (unsigned int d = 0; d < dealii::SymmetricTensor<2,dim>::n_independent_components; ++d)
{
// variables from FEValuesBase, but they aren't initialized yet
// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = make_shape_function_to_row_table (fe);
+ = internal::make_shape_function_to_row_table (fe);
for (unsigned int d = 0; d < dim*dim; ++d)
{
// the rows in the tables storing the data by shape function and
// nonzero component
this->shape_function_to_row_table
- = make_shape_function_to_row_table (fe);
+ = internal::make_shape_function_to_row_table (fe);
// count the total number of non-zero components accumulated
// over all shape functions
boost::container::small_vector<Number, 200> dof_values(dofs_per_cell);
for (unsigned int i=0; i<dofs_per_cell; ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_values(dof_values.data(), this->finite_element_output.shape_values, values);
}
boost::container::small_vector<Number, 200> dof_values(dofs_per_cell);
for (unsigned int i=0; i<dofs_per_cell; ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_values(dof_values.data(),
this->finite_element_output.shape_values,
*fe,
boost::container::small_vector<Number, 200> dof_values(indices.size());
for (unsigned int i=0; i<indices.size(); ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_values(dof_values.data(),
this->finite_element_output.shape_values,
*fe,
boost::container::small_vector<Number, 200> dof_values(dofs_per_cell);
for (unsigned int i=0; i<dofs_per_cell; ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_derivatives(dof_values.data(), this->finite_element_output.shape_gradients,
gradients);
}
boost::container::small_vector<Number, 200> dof_values(indices.size());
for (unsigned int i=0; i<indices.size(); ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_derivatives(dof_values.data(),
this->finite_element_output.shape_gradients,
*fe,
boost::container::small_vector<Number, 200> dof_values(dofs_per_cell);
for (unsigned int i=0; i<dofs_per_cell; ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_derivatives(dof_values.data(), this->finite_element_output.shape_hessians,
hessians);
}
boost::container::small_vector<Number, 200> dof_values(indices.size());
for (unsigned int i=0; i<indices.size(); ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_derivatives(dof_values.data(),
this->finite_element_output.shape_hessians,
*fe,
boost::container::small_vector<Number, 200> dof_values(dofs_per_cell);
for (unsigned int i=0; i<dofs_per_cell; ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_laplacians(dof_values.data(), this->finite_element_output.shape_hessians,
laplacians);
}
boost::container::small_vector<Number, 200> dof_values(indices.size());
for (unsigned int i=0; i<indices.size(); ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_laplacians(dof_values.data(), this->finite_element_output.shape_hessians,
*fe, this->finite_element_output.shape_function_to_row_table,
laplacians, false,
boost::container::small_vector<Number, 200> dof_values(indices.size());
for (unsigned int i=0; i<indices.size(); ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_laplacians(dof_values.data(), this->finite_element_output.shape_hessians,
*fe, this->finite_element_output.shape_function_to_row_table,
laplacians, quadrature_points_fastest,
boost::container::small_vector<Number, 200> dof_values(dofs_per_cell);
for (unsigned int i=0; i<dofs_per_cell; ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_derivatives(dof_values.data(), this->finite_element_output.shape_3rd_derivatives,
third_derivatives);
}
boost::container::small_vector<Number, 200> dof_values(indices.size());
for (unsigned int i=0; i<indices.size(); ++i)
- dof_values[i] = get_vector_element (fe_function, indices[i]);
+ dof_values[i] = internal::get_vector_element (fe_function, indices[i]);
internal::do_function_derivatives(dof_values.data(),
this->finite_element_output.shape_3rd_derivatives,
*fe,