git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@29416
0785d39b-7218-0410-832d-
ea1e28bc413d
void InverseMatrix<Matrix>::vmult (Vector<double> &dst,
const Vector<double> &src) const
{
- SolverControl solver_control (std::max(src.size(), static_cast<std::size_t> 200),
+ SolverControl solver_control (std::max(src.size(), static_cast<std::size_t> (200)),
1e-8*src.l2_norm());
SolverCG<> cg (solver_control);
BoundaryValues<dim> boundary_values_function;
boundary_values_function.set_time(time);
- std::map<unsigned int, double> boundary_values;
+ std::map<types::global_dof_index, double> boundary_values;
VectorTools::interpolate_boundary_values(dof_handler,
0,
boundary_values_function,
{
return vector.GlobalLength();
}
+
+ int gid(const Epetra_Map &map, unsigned int i)
+ {
+ return map.GID(i);
+ }
#else
long long int global_length (const Epetra_MultiVector &vector)
{
return vector.GlobalLength64();
}
+
+ long long int gid(const Epetra_Map &map, dealii::types::global_dof_index i)
+ {
+ return map.GID64(i);
+ }
#endif
}
for (size_type row=0; row<my_size; ++row)
{
TrilinosWrappers::types::int_type global_row_id =
- constant_modes_are_global ? domain_map.GID(row) : row;
+ constant_modes_are_global ? gid(domain_map,row) : row;
distributed_constant_modes[d][row] =
additional_data.constant_modes[d][global_row_id];
}
In the beginning the Universe was created. This has made a lot of
people very angry and has been widely regarded as a bad move.
Douglas Adams