#include "../tests.h"
#include <lac/trilinos_sparse_matrix.h>
-#include <lac/trilinos_parallel_sparse_matrix.h>
+#include <lac/trilinos_sparse_matrix.h>
#include <lac/vector.h>
#include <fstream>
test (v1);
// check
- // TrilinosWrappers::MPI::SparseMatrix
+ // TrilinosWrappers::SparseMatrix
MPI_Comm mpi_communicator (MPI_COMM_WORLD);
int n_jobs=1;
MPI_Comm_size (mpi_communicator, &n_jobs);
const unsigned int n_mpi_processes=static_cast<unsigned int>(n_jobs);
Assert(n_dofs%n_mpi_processes==0, ExcInternalError());
const unsigned int n_local_dofs=n_dofs/n_mpi_processes;
- TrilinosWrappers::MPI::SparseMatrix
+ TrilinosWrappers::SparseMatrix
v2 (mpi_communicator, n_dofs, n_dofs, n_local_dofs, n_local_dofs, 5);
test (v2);
}
#include "../tests.h"
-#include <lac/trilinos_parallel_vector.h>
+#include <lac/trilinos_vector.h>
#include <fstream>
#include <iostream>
-//---------------------------- trilinos_parallel_sparse_matrix_01.cc ---------------------------
+//---------------------------- trilinos_sparse_matrix_01.cc ---------------------------
// $Id$
// Version: $Name$
//
// to the file deal.II/doc/license.html for the text and
// further information on this license.
//
-//---------------------------- trilinos_parallel_sparse_matrix_01.cc ---------------------------
+//---------------------------- trilinos_sparse_matrix_01.cc ---------------------------
-// TrilinosWrappers::MPI::SparseMatrix::reinit(CompressedSparsityPattern) should
+// TrilinosWrappers::SparseMatrix::reinit(CompressedSparsityPattern) should
// create a matrix that, when filled with elements that match the sparsity
// pattern, doesn't require any more memory allocation any more. This is
// tricky to get right, though, and took a while until it worked.
// malloc calls have been performed
#include "../tests.h"
-#include <lac/trilinos_parallel_sparse_matrix.h>
+#include <lac/trilinos_sparse_matrix.h>
#include <lac/compressed_sparsity_pattern.h>
#include <fstream>
#include <cstdlib>
// now create a matrix with this sparsity
// pattern
- TrilinosWrappers::MPI::SparseMatrix m;
+ TrilinosWrappers::SparseMatrix m;
m.reinit (MPI_COMM_WORLD, csp, local_rows_per_process,
local_rows_per_process, get_this_mpi_process());
int main (int argc,char **argv)
{
- std::ofstream logfile("parallel_sparse_matrix_01/output");
+ std::ofstream logfile("sparse_matrix_01/output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include "../tests.h"
#include <lac/sparse_matrix.h>
-#include <lac/trilinos_parallel_sparse_matrix.h>
-#include <lac/trilinos_parallel_vector.h>
+#include <lac/trilinos_sparse_matrix.h>
+#include <lac/trilinos_vector.h>
#include <fstream>
#include <iostream>
const unsigned int N = 200;
// build the sparse matrix
- TrilinosWrappers::MPI::SparseMatrix matrix (PETSC_COMM_WORLD,
+ TrilinosWrappers::SparseMatrix matrix (PETSC_COMM_WORLD,
N*N, N*N,
N*N, N*N,
5);
#include "../tests.h"
#include <lac/sparse_matrix.h>
-#include <lac/trilinos_parallel_sparse_matrix.h>
-#include <lac/trilinos_parallel_vector.h>
+#include <lac/trilinos_sparse_matrix.h>
+#include <lac/trilinos_vector.h>
#include <fstream>
#include <iostream>
}
// build the sparse matrix
- TrilinosWrappers::MPI::SparseMatrix matrix (PETSC_COMM_WORLD,
+ TrilinosWrappers::SparseMatrix matrix (PETSC_COMM_WORLD,
N*N, N*N,
N*N, N*N,
5);