TrilinosWrappers::MPI::BlockVector &v,
bool omit_zeroing_entries)
{
- v.reinit(matrix.range_partitioner(), omit_zeroing_entries);
+ v.reinit(matrix.locally_owned_range_indices(),
+ matrix.get_mpi_communicator(), omit_zeroing_entries);
}
template <typename Matrix>
TrilinosWrappers::MPI::BlockVector &v,
bool omit_zeroing_entries)
{
- v.reinit(matrix.domain_partitioner(), omit_zeroing_entries);
+ v.reinit(matrix.locally_owned_domain_indices(),
+ matrix.get_mpi_communicator(), omit_zeroing_entries);
}
};
{
deallog.push("Trilinos");
- TrilinosWrappers::Vector v(17);
+ TrilinosWrappers::Vector v;
+ v.reinit(17);
test (v);
deallog.pop();
}
{
deallog.push("Trilinos");
- TrilinosWrappers::BlockVector v(3);
+ TrilinosWrappers::BlockVector v;
+ v.reinit(3);
v.block(0).reinit(7);
v.block(1).reinit(5);
v.block(2).reinit(3);
sparsity_pattern.compress();
TrilinosWrappers::SparseMatrix A (sparsity_pattern);
- TrilinosWrappers::Vector b (A.domain_partitioner());
- TrilinosWrappers::MPI::Vector c (A.domain_partitioner());
+ TrilinosWrappers::Vector b;
+ b.reinit(A.locally_owned_domain_indices());
+ TrilinosWrappers::MPI::Vector c;
+ c.reinit(A.locally_owned_domain_indices());
for (unsigned int i=0; i < rc; ++i)
{
A.set(i,i,2.0);
sparsity_pattern.compress();
TrilinosWrappers::SparseMatrix A (sparsity_pattern);
- TrilinosWrappers::Vector b (A.domain_partitioner());
- TrilinosWrappers::MPI::Vector c (A.domain_partitioner());
+ TrilinosWrappers::Vector b;
+ b.reinit(A.domain_partitioner());
+ TrilinosWrappers::MPI::Vector c;
+ c.reinit(A.locally_owned_domain_indices());
for (unsigned int i=0; i < rc; ++i)
{
A.set(i,i,2.0);
A.reinit(csp);
testproblem.five_point(A);
- TrilinosWrappers::Vector f(dim);
- TrilinosWrappers::Vector u(dim);
+ TrilinosWrappers::Vector f;
+ f.reinit(dim);
+ TrilinosWrappers::Vector u;
+ u.reinit(dim);
A.compress (VectorOperation::insert);
f.compress (VectorOperation::insert);
A.reinit(csp);
testproblem.five_point(A);
- TrilinosWrappers::Vector f(dim);
- TrilinosWrappers::Vector u(dim);
+ TrilinosWrappers::Vector f;
+ f.reinit(dim);
+ TrilinosWrappers::Vector u;
+ u.reinit(dim);
A.compress (VectorOperation::insert);
f.compress (VectorOperation::insert);
TrilinosWrappers::SparseMatrix C (rc,rc,rc);
TrilinosWrappers::SparseMatrix D (rc,rc,rc);
- VectorType y (rc);
- VectorType g (rc);
+ VectorType y;
+ y.reinit(rc);
+ VectorType g;
+ g.reinit(rc);
for (unsigned int i=0; i < rc; ++i)
{
A.set(i,i, 1.0*(i+1));