has_ghosts = vector->Map().UniqueGIDs()==false;
- const TrilinosWrappers::types::int_type size = parallel_partitioner.NumMyElements();
+ const int size = parallel_partitioner.NumMyElements();
// Need to copy out values, since the
// deal.II might not use doubles, so
// that a direct access is not possible.
- for (TrilinosWrappers::types::int_type i=0; i<size; ++i)
- (*vector)[0][i] = v(parallel_partitioner.GID(i));
+ for (int i=0; i<size; ++i)
+ (*vector)[0][i] = v(parallel_partitioner.GID64(i));
}
if (size() != v.size())
{
vector.reset (new Epetra_FEVector(Epetra_Map
- (static_cast<int>(v.size()), 0,
+ (static_cast<TrilinosWrappers::types::int_type>(v.size()), 0,
#ifdef DEAL_II_WITH_MPI
Epetra_MpiComm(MPI_COMM_SELF)
#else
VectorBase::size_type
VectorBase::size () const
{
- return (size_type) (vector->Map().MaxAllGID() + 1 -
- vector->Map().MinAllGID());
+ return (size_type) (vector->Map().MaxAllGID64() + 1 -
+ vector->Map().MinAllGID64());
}
{
matrix->ExtractMyRowView (i, num_entries, values, indices);
for (TrilinosWrappers::types::int_type j=0; j<num_entries; ++j)
- out << "(" << matrix->GRID(i) << "," << matrix->GCID(indices[j]) << ") "
+ out << "(" << matrix->GRID64(i) << "," << matrix->GCID64(indices[j]) << ") "
<< values[j] << std::endl;
}
}
{
graph->ExtractMyRowView (i, num_entries, indices);
for (TrilinosWrappers::types::int_type j=0; j<num_entries; ++j)
- out << "(" << i << "," << indices[graph->GRID(j)] << ") "
+ out << "(" << i << "," << indices[graph->GRID64(j)] << ") "
<< std::endl;
}
}
// j horizontal, gnuplot output is
// x-y, that is we have to exchange
// the order of output
- out << indices[graph->GRID(static_cast<TrilinosWrappers::types::int_type>(j))]
+ out << indices[graph->GRID64(static_cast<TrilinosWrappers::types::int_type>(j))]
<< " " << -static_cast<TrilinosWrappers::types::int_type>(row)
<< std::endl;
}
try
{
{
- std::vector<types::global_dof_index> row_lengths (5,
- static_cast<types::global_dof_index>(3));
+ std::vector<unsigned int> row_lengths (5,3U);
row_lengths.back() = 2;
- TrilinosWrappers::SparseMatrix m (5U,5U,row_lengths);
+ TrilinosWrappers::SparseMatrix m (static_cast<types::global_dof_index>(5U),
+ static_cast<types::global_dof_index>(5U),row_lengths);
test (m);
}
}