chunk_sparse_matrix.inst.in
constraint_matrix.inst.in
full_matrix.inst.in
+ lapack_full_matrix.inst.in
operator.inst.in
parallel_vector.inst.in
precondition_block.inst.in
relaxation_block.inst.in
sparse_matrix_ez.inst.in
sparse_matrix.inst.in
+ trilinos_sparse_matrix.inst.in
trilinos_vector_base.inst.in
vector.inst.in
vector_memory.inst.in
-template class LAPACKFullMatrix<double>;
-template LAPACKFullMatrix<double> &
-LAPACKFullMatrix<double>::operator = (const FullMatrix<double> &M);
-template LAPACKFullMatrix<double> &
-LAPACKFullMatrix<double>::operator = (const FullMatrix<float> &M);
-
-template class LAPACKFullMatrix<float>;
-template LAPACKFullMatrix<float> &
-LAPACKFullMatrix<float>::operator = (const FullMatrix<double> &M);
-template LAPACKFullMatrix<float> &
-LAPACKFullMatrix<float>::operator = (const FullMatrix<float> &M);
-
-template class LAPACKFullMatrix<long double>;
-template LAPACKFullMatrix<long double> &
-LAPACKFullMatrix<long double>::operator = (const FullMatrix<long double> &M);
-template LAPACKFullMatrix<long double> &
-LAPACKFullMatrix<long double>::operator = (const FullMatrix<double> &M);
-template LAPACKFullMatrix<long double> &
-LAPACKFullMatrix<long double>::operator = (const FullMatrix<float> &M);
-
-template class PreconditionLU<double>;
-template class PreconditionLU<float>;
+#include "lapack_full_matrix.inst"
+
DEAL_II_NAMESPACE_CLOSE
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2013 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+
+
+for (S : REAL_SCALARS)
+ {
+ template class LAPACKFullMatrix<S>;
+ template class PreconditionLU<S>;
+ }
+
+for (S1, S2 : REAL_SCALARS)
+ {
+ template LAPACKFullMatrix<S1> &
+ LAPACKFullMatrix<S1>::operator = (const FullMatrix<S2> &M);
+ }
sizeof(int)*local_size() +
static_memory);
}
+}
+
+// explicit instantiations
+#include "trilinos_sparse_matrix.inst"
- // explicit instantiations
- //
+// TODO: put these instantiations into generic file
+namespace TrilinosWrappers
+{
template void
SparseMatrix::reinit (const dealii::SparsityPattern &);
template void
const CompressedSetSparsityPattern &,
const bool);
- template void
- SparseMatrix::reinit (const dealii::SparseMatrix<float> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
- template void
- SparseMatrix::reinit (const dealii::SparseMatrix<double> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
- template void
- SparseMatrix::reinit (const dealii::SparseMatrix<long double> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
-
- template void
- SparseMatrix::reinit (const Epetra_Map &,
- const dealii::SparseMatrix<float> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
- template void
- SparseMatrix::reinit (const Epetra_Map &,
- const dealii::SparseMatrix<double> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
- template void
- SparseMatrix::reinit (const Epetra_Map &,
- const dealii::SparseMatrix<long double> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
-
- template void
- SparseMatrix::reinit (const Epetra_Map &,
- const Epetra_Map &,
- const dealii::SparseMatrix<float> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
- template void
- SparseMatrix::reinit (const Epetra_Map &,
- const Epetra_Map &,
- const dealii::SparseMatrix<double> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
- template void
- SparseMatrix::reinit (const Epetra_Map &,
- const Epetra_Map &,
- const dealii::SparseMatrix<long double> &,
- const double,
- const bool,
- const dealii::SparsityPattern *);
-
-
}
DEAL_II_NAMESPACE_CLOSE
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2013 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+
+
+for (S : REAL_SCALARS)
+ {
+ namespace TrilinosWrappers
+ \{
+ template void
+ SparseMatrix::reinit (const dealii::SparseMatrix<S> &,
+ const double,
+ const bool,
+ const dealii::SparsityPattern *);
+ template void
+ SparseMatrix::reinit (const Epetra_Map &,
+ const dealii::SparseMatrix<S> &,
+ const double,
+ const bool,
+ const dealii::SparsityPattern *);
+ template void
+ SparseMatrix::reinit (const Epetra_Map &,
+ const Epetra_Map &,
+ const dealii::SparseMatrix<S> &,
+ const double,
+ const bool,
+ const dealii::SparsityPattern *);
+ \}
+ }