template <class T>
- void set_zero_all(const std::vector<size_type> &cm, dealii::Vector<T> &vec)
+ void set_zero_all(const std::vector<size_type> &cm,
+ dealii::Vector<T> &vec)
{
set_zero_serial(cm, vec);
}
template <class T>
- void set_zero_all(const std::vector<size_type> &cm, dealii::BlockVector<T> &vec)
+ void set_zero_all(const std::vector<size_type> &cm,
+ dealii::BlockVector<T> &vec)
{
set_zero_serial(cm, vec);
}
template <typename LocalType>
static inline
LocalType resolve_matrix_entry (const GlobalRowsFromLocal &global_rows,
- const GlobalRowsFromLocal &global_cols,
- const size_type i,
- const size_type j,
- const size_type loc_row,
+ const GlobalRowsFromLocal &global_cols,
+ const size_type i,
+ const size_type j,
+ const size_type loc_row,
const FullMatrix<LocalType> &local_matrix)
{
const size_type loc_col = global_cols.local_row(j);
template <typename number, typename LocalType>
inline
void
- resolve_matrix_row (const GlobalRowsFromLocal &global_rows,
- const GlobalRowsFromLocal &global_cols,
- const size_type i,
- const size_type column_start,
- const size_type column_end,
- const FullMatrix<LocalType> &local_matrix,
- size_type *&col_ptr,
- number *&val_ptr)
+ resolve_matrix_row (const GlobalRowsFromLocal &global_rows,
+ const GlobalRowsFromLocal &global_cols,
+ const size_type i,
+ const size_type column_start,
+ const size_type column_end,
+ const FullMatrix<LocalType> &local_matrix,
+ size_type *&col_ptr,
+ number *&val_ptr)
{
if (column_end == column_start)
return;
template <typename number, typename LocalType>
inline
void
- resolve_matrix_row (const GlobalRowsFromLocal &global_rows,
- const size_type i,
- const size_type column_start,
- const size_type column_end,
+ resolve_matrix_row (const GlobalRowsFromLocal &global_rows,
+ const size_type i,
+ const size_type column_start,
+ const size_type column_end,
const FullMatrix<LocalType> &local_matrix,
- SparseMatrix<number> *sparse_matrix)
+ SparseMatrix<number> *sparse_matrix)
{
if (column_end == column_start)
return;
// global row global_rows[i] as before, now for sparsity pattern
inline
void
- resolve_matrix_row (const GlobalRowsFromLocal &global_rows,
- const size_type i,
- const size_type column_start,
- const size_type column_end,
- const Table<2,bool> &dof_mask,
+ resolve_matrix_row (const GlobalRowsFromLocal &global_rows,
+ const size_type i,
+ const size_type column_start,
+ const size_type column_end,
+ const Table<2,bool> &dof_mask,
std::vector<size_type>::iterator &col_ptr)
{
if (column_end == column_start)
// do actually do something with this dof
template <typename MatrixType, typename VectorType>
inline void
- set_matrix_diagonals (const internals::GlobalRowsFromLocal &global_rows,
- const std::vector<size_type> &local_dof_indices,
- const FullMatrix<typename MatrixType::value_type> &local_matrix,
- const ConstraintMatrix &constraints,
- MatrixType &global_matrix,
- VectorType &global_vector,
- bool use_inhomogeneities_for_rhs)
+ set_matrix_diagonals (const internals::GlobalRowsFromLocal &global_rows,
+ const std::vector<size_type> &local_dof_indices,
+ const FullMatrix<typename MatrixType::value_type> &local_matrix,
+ const ConstraintMatrix &constraints,
+ MatrixType &global_matrix,
+ VectorType &global_vector,
+ bool use_inhomogeneities_for_rhs)
{
if (global_rows.n_constraints() > 0)
{
template <typename MatrixType, typename VectorType>
void
ConstraintMatrix::distribute_local_to_global (
- const FullMatrix<typename MatrixType::value_type> &local_matrix,
- const Vector<typename VectorType::value_type> &local_vector,
- const std::vector<size_type> &local_dof_indices,
- MatrixType &global_matrix,
- VectorType &global_vector,
- bool use_inhomogeneities_for_rhs,
+ const FullMatrix<typename MatrixType::value_type> &local_matrix,
+ const Vector<typename VectorType::value_type> &local_vector,
+ const std::vector<size_type> &local_dof_indices,
+ MatrixType &global_matrix,
+ VectorType &global_vector,
+ bool use_inhomogeneities_for_rhs,
std::integral_constant<bool, false>) const
{
// check whether we work on real vectors or we just used a dummy when
template <typename MatrixType, typename VectorType>
void
ConstraintMatrix::
-distribute_local_to_global (const FullMatrix<typename MatrixType::value_type> &local_matrix,
- const Vector<typename VectorType::value_type> &local_vector,
- const std::vector<size_type> &local_dof_indices,
- MatrixType &global_matrix,
- VectorType &global_vector,
- bool use_inhomogeneities_for_rhs,
- std::integral_constant<bool, true>) const
+distribute_local_to_global (
+ const FullMatrix<typename MatrixType::value_type> &local_matrix,
+ const Vector<typename VectorType::value_type> &local_vector,
+ const std::vector<size_type> &local_dof_indices,
+ MatrixType &global_matrix,
+ VectorType &global_vector,
+ bool use_inhomogeneities_for_rhs,
+ std::integral_constant<bool, true>) const
{
const bool use_vectors = (local_vector.size() == 0 &&
global_vector.size() == 0) ? false : true;
template <typename MatrixType>
void
ConstraintMatrix::distribute_local_to_global (
- const FullMatrix<typename MatrixType::value_type> &local_matrix,
- const std::vector<size_type> &row_indices,
- const std::vector<size_type> &col_indices,
- MatrixType &global_matrix) const
+ const FullMatrix<typename MatrixType::value_type> &local_matrix,
+ const std::vector<size_type> &row_indices,
+ const std::vector<size_type> &col_indices,
+ MatrixType &global_matrix) const
{
distribute_local_to_global(local_matrix, row_indices, *this,
col_indices, global_matrix);
template <typename MatrixType>
void
ConstraintMatrix::distribute_local_to_global (
- const FullMatrix<typename MatrixType::value_type> &local_matrix,
- const std::vector<size_type> &row_indices,
- const ConstraintMatrix &col_constraint_matrix,
- const std::vector<size_type> &col_indices,
- MatrixType &global_matrix) const
+ const FullMatrix<typename MatrixType::value_type> &local_matrix,
+ const std::vector<size_type> &row_indices,
+ const ConstraintMatrix &col_constraint_matrix,
+ const std::vector<size_type> &col_indices,
+ MatrixType &global_matrix) const
{
typedef typename MatrixType::value_type number;