]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fix a few references to non-existent classes.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 23 Oct 2008 03:39:13 +0000 (03:39 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 23 Oct 2008 03:39:13 +0000 (03:39 +0000)
git-svn-id: https://svn.dealii.org/trunk@17314 0785d39b-7218-0410-832d-ea1e28bc413d

tests/trilinos/64.cc
tests/trilinos/65.cc
tests/trilinos/parallel_sparse_matrix_01.cc
tests/trilinos/slowness_03.cc
tests/trilinos/slowness_04.cc

index 0538ad0eb9e1d298e936f4d3261e1d9cffcd71c6..df2236546aadb694f775a8f7463235744a58e2df 100644 (file)
@@ -19,7 +19,7 @@
 
 #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>
@@ -59,14 +59,14 @@ int main (int argc,char **argv)
         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);
       }
index 428b6553f56b43c740fae1471567b68ff02a0d25..5b264213bb3ed21d83d8cf5569e008c8f5dc0a97 100644 (file)
@@ -16,7 +16,7 @@
 
 
 #include "../tests.h"
-#include <lac/trilinos_parallel_vector.h>
+#include <lac/trilinos_vector.h>
 
 #include <fstream>
 #include <iostream>
index 5aebe92d71efe07cab7b74900e7d22929f36f45b..9f3f3cda0ec89fec4a751b9c00a09624a1b0d35a 100644 (file)
@@ -1,4 +1,4 @@
-//----------------------------  trilinos_parallel_sparse_matrix_01.cc  ---------------------------
+//----------------------------  trilinos_sparse_matrix_01.cc  ---------------------------
 //    $Id$
 //    Version: $Name$ 
 //
@@ -9,10 +9,10 @@
 //    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.
@@ -24,7 +24,7 @@
 // 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>
@@ -95,7 +95,7 @@ void test ()
   
                                    // 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());
 
@@ -115,7 +115,7 @@ void test ()
 
 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);
index 4d4a42e4365288ffbc127f2faa3c83036ac61f2d..8ed90df490711f5c15ee4842a2a4826b62e05e61 100644 (file)
@@ -21,8 +21,8 @@
 
 #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>
 
@@ -32,7 +32,7 @@ void test ()
   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);
index 1638c844c9cb34590f5d49d843e57e9b0bd6e41f..f4def4cc4b6c174114b9bb42d1c403569b8d21f4 100644 (file)
@@ -27,8 +27,8 @@
 
 #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>
 
@@ -60,7 +60,7 @@ void test ()
   }
   
                                    // 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);

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


Typeset in Trocchi and Trocchi Bold Sans Serif.