// into the matrix for the
// diagonal block
BlockList::const_iterator row = additional_data.block_list->begin(block);
- BlockList::const_iterator end = additional_data.block_list->end(block);
for (unsigned int row_cell=0; row_cell<bs; ++row_cell, ++row)
{
//TODO:[GK] Optimize here
x_cell.reinit(bs);
// Collect off-diagonal parts
BlockList::const_iterator row = additional_data.block_list->begin(block);
- BlockList::const_iterator end = additional_data.block_list->end(block);
for (unsigned int row_cell=0; row_cell<bs; ++row_cell, ++row)
{
b_cell(row_cell) = src(*row);
Assert (!PointerComparison::equal(&src, &dst), ExcSourceEqualsDestination());
parallel::apply_to_subranges (0U, m(),
- std_cxx1x::bind (internal::SparseMatrix::vmult_on_subrange
+ std_cxx1x::bind (&internal::SparseMatrix::vmult_on_subrange
<number,InVector,OutVector>,
_1, _2,
val,
Assert (!PointerComparison::equal(&src, &dst), ExcSourceEqualsDestination());
parallel::apply_to_subranges (0U, m(),
- std_cxx1x::bind (internal::SparseMatrix::vmult_on_subrange
+ std_cxx1x::bind (&internal::SparseMatrix::vmult_on_subrange
<number,InVector,OutVector>,
_1, _2,
val,
return
parallel::accumulate_from_subranges<number>
- (std_cxx1x::bind (internal::SparseMatrix::matrix_norm_sqr_on_subrange
+ (std_cxx1x::bind (&internal::SparseMatrix::matrix_norm_sqr_on_subrange
<number,Vector<somenumber> >,
_1, _2,
val, cols->rowstart, cols->colnums,
return
parallel::accumulate_from_subranges<number>
- (std_cxx1x::bind (internal::SparseMatrix::matrix_scalar_product_on_subrange
+ (std_cxx1x::bind (&internal::SparseMatrix::matrix_scalar_product_on_subrange
<number,Vector<somenumber> >,
_1, _2,
val, cols->rowstart, cols->colnums,
return
std::sqrt (parallel::accumulate_from_subranges<number>
- (std_cxx1x::bind (internal::SparseMatrix::residual_sqr_on_subrange
+ (std_cxx1x::bind (&internal::SparseMatrix::residual_sqr_on_subrange
<number,Vector<somenumber>,Vector<somenumber> >,
_1, _2,
val, cols->rowstart, cols->colnums,
*/
std::size_t memory_consumption () const;
//@}
-
+
/**
* Write the data of this object to
* a stream for the purpose of serialization.
- */
+ */
template <class Archive>
void save (Archive & ar, const unsigned int version) const;
/**
- * Read the data of this object
+ * Read the data of this object
* from a stream for the purpose of serialization.
- */
+ */
template <class Archive>
void load (Archive & ar, const unsigned int version);
// forward to serialization
// function in the base class.
ar & static_cast<const Subscriptor &>(*this);
-
+
ar & vec_size & max_vec_size ;
ar & boost::serialization::make_array(val, max_vec_size);
}
// forward to serialization
// function in the base class.
ar & static_cast<Subscriptor &>(*this);
-
+
ar & vec_size & max_vec_size ;
-
+
val = new Number[max_vec_size];
ar & boost::serialization::make_array(val, max_vec_size);
}
std::ostream&
operator << (std::ostream& os, const Vector<number>& v)
{
- v.print(os);
+ v.print(os);
return os;
}
operator << (LogStream& os, const Vector<number>& v)
{
v.print(os);
- return os;
+ return os;
}
// Loop over all cells
#ifdef DEAL_II_MESHWORKER_PARALLEL
WorkStream::run(begin, end,
- std_cxx1x::bind(cell_action<INFOBOX, DOFINFO, dim, spacedim, ITERATOR>, _1, _3, _2,
- cell_worker, boundary_worker, face_worker, cells_first, true),
- std_cxx1x::bind(internal::assemble<dim,DOFINFO,ASSEMBLER>, _1, &assembler),
+ std_cxx1x::bind(&cell_action<INFOBOX, DOFINFO, dim, spacedim, ITERATOR>, _1, _3, _2,
+ cell_worker, boundary_worker, face_worker, cells_first, true),
+ std_cxx1x::bind(&internal::assemble<dim,DOFINFO,ASSEMBLER>, _1, &assembler),
info, dof_info);
#else
for (ITERATOR cell = begin; cell != end; ++cell)
// avoid compiler warnings
//TODO:[WB] Should t be used to trace errors?
ssize_t t = write (detached_mode_data->server_client_pipe[1], "7", 1);
- t = 0;
+ (void)t;
// then also delete data
delete detached_mode_data;
detached_mode_data = 0;
// warnings
//TODO:[WB] Use t to trace errors?
int t = pipe(detached_mode_data->server_client_pipe);
- t = pipe(detached_mode_data->client_server_pipe);
+ (void)t;
// fflush(NULL) is said to be a
// good idea before fork()