template <bool ignore_invalid_symbols = false,
int rank,
int dim,
+ typename ExpressionType,
typename ValueType>
void
- add_to_substitution_map(types::substitution_map &substitution_map,
- const Tensor<rank, dim, Expression> &symbol_tensor,
- const Tensor<rank, dim, ValueType> & value_tensor);
+ add_to_substitution_map(
+ types::substitution_map & substitution_map,
+ const Tensor<rank, dim, ExpressionType> &symbol_tensor,
+ const Tensor<rank, dim, ValueType> & value_tensor);
/**
* A convenience function for adding an entry to the @p substitution_map.
template <bool ignore_invalid_symbols = false,
int rank,
int dim,
+ typename ExpressionType,
typename ValueType>
void
add_to_substitution_map(
- types::substitution_map & substitution_map,
- const SymmetricTensor<rank, dim, Expression> &symbol_tensor,
- const SymmetricTensor<rank, dim, ValueType> & value_tensor);
+ types::substitution_map & substitution_map,
+ const SymmetricTensor<rank, dim, ExpressionType> &symbol_tensor,
+ const SymmetricTensor<rank, dim, ValueType> & value_tensor);
//@}
int dim,
typename ValueType,
template <int, int, typename> class TensorType>
- std::vector<std::pair<Expression, ValueType>>
+ std::vector<std::pair<ExpressionType, ValueType>>
tensor_substitution_map(
- const TensorType<rank, dim, Expression> &symbol_tensor,
- const TensorType<rank, dim, ValueType> & value_tensor)
+ const TensorType<rank, dim, ExpressionType> &symbol_tensor,
+ const TensorType<rank, dim, ValueType> & value_tensor)
{
- std::vector<std::pair<Expression, ValueType>> symbol_values;
+ std::vector<std::pair<ExpressionType, ValueType>> symbol_values;
for (unsigned int i = 0; i < symbol_tensor.n_independent_components;
++i)
{
}
- template <int dim, typename ValueType>
- std::vector<std::pair<Expression, ValueType>>
+ template <int dim, typename ExpressionType, typename ValueType>
+ std::vector<std::pair<ExpressionType, ValueType>>
tensor_substitution_map(
- const SymmetricTensor<4, dim, Expression> &symbol_tensor,
- const SymmetricTensor<4, dim, ValueType> & value_tensor)
+ const SymmetricTensor<4, dim, ExpressionType> &symbol_tensor,
+ const SymmetricTensor<4, dim, ValueType> & value_tensor)
{
- std::vector<std::pair<Expression, ValueType>> symbol_values;
+ std::vector<std::pair<ExpressionType, ValueType>> symbol_values;
for (unsigned int i = 0;
i < SymmetricTensor<2, dim>::n_independent_components;
++i)
template <bool ignore_invalid_symbols,
int rank,
int dim,
+ typename ExpressionType,
typename ValueType>
void
- add_to_substitution_map(types::substitution_map &substitution_map,
- const Tensor<rank, dim, Expression> &symbol_tensor,
- const Tensor<rank, dim, ValueType> & value_tensor)
+ add_to_substitution_map(
+ types::substitution_map & substitution_map,
+ const Tensor<rank, dim, ExpressionType> &symbol_tensor,
+ const Tensor<rank, dim, ValueType> & value_tensor)
{
add_to_substitution_map<ignore_invalid_symbols>(
substitution_map,
template <bool ignore_invalid_symbols,
int rank,
int dim,
+ typename ExpressionType,
typename ValueType>
void
add_to_substitution_map(
- types::substitution_map & substitution_map,
- const SymmetricTensor<rank, dim, Expression> &symbol_tensor,
- const SymmetricTensor<rank, dim, ValueType> & value_tensor)
+ types::substitution_map & substitution_map,
+ const SymmetricTensor<rank, dim, ExpressionType> &symbol_tensor,
+ const SymmetricTensor<rank, dim, ValueType> & value_tensor)
{
add_to_substitution_map<ignore_invalid_symbols>(
substitution_map,