135:
public ContainerImpl<MatrixType, typename InverseType::scalar_type>
147 using matrix_type = MatrixType;
153 using inverse_type = InverseType;
155 using typename Container<MatrixType>::SC;
156 using typename Container<MatrixType>::LO;
157 using typename Container<MatrixType>::GO;
158 using typename Container<MatrixType>::NO;
160 using typename Container<MatrixType>::mv_type;
161 using typename Container<MatrixType>::map_type;
162 using typename Container<MatrixType>::vector_type;
163 using typename Container<MatrixType>::import_type;
165 using InverseScalar =
typename InverseType::scalar_type;
166 using InverseLocalOrdinal =
typename InverseType::local_ordinal_type;
167 using InverseGlobalOrdinal =
typename InverseType::global_ordinal_type;
168 using InverseNode =
typename InverseType::node_type;
170 using typename ContainerImpl<MatrixType, InverseScalar>::block_crs_matrix_type;
172 using inverse_mv_type = Tpetra::MultiVector<InverseScalar, InverseLocalOrdinal, InverseGlobalOrdinal, InverseNode>;
173 using InverseCrs = Tpetra::CrsMatrix<InverseScalar, InverseLocalOrdinal, InverseGlobalOrdinal, InverseNode>;
174 using InverseMap =
typename Tpetra::Map<InverseLocalOrdinal, InverseGlobalOrdinal, InverseNode>;
177 using typename Container<MatrixType>::ConstHostView;
178 using HostViewInverse =
typename inverse_mv_type::dual_view_type::t_host;
180 static_assert(std::is_same<MatrixType,
181 Tpetra::RowMatrix<SC, LO, GO, NO>>::value,
"Ifpack2::SparseContainer: Please use MatrixType = Tpetra::RowMatrix.");
191 using typename Container<MatrixType>::row_matrix_type;
209 const Teuchos::Array<Teuchos::Array<LO> >& partitions,
210 const Teuchos::RCP<const import_type>& importer,
221 virtual void setParameters(
const Teuchos::ParameterList& List);
240 apply (ConstHostView X,
243 Teuchos::ETransp mode = Teuchos::NO_TRANS,
244 SC alpha = Teuchos::ScalarTraits<SC>::one(),
245 SC beta = Teuchos::ScalarTraits<SC>::zero())
const;
253 Teuchos::ETransp mode = Teuchos::NO_TRANS,
254 SC alpha = Teuchos::ScalarTraits<SC>::one(),
255 SC beta = Teuchos::ScalarTraits<SC>::zero())
const;
264 virtual std::ostream&
print(std::ostream& os)
const;
275 describe (Teuchos::FancyOStream &out,
276 const Teuchos::EVerbosityLevel verbLevel =
277 Teuchos::Describable::verbLevel_default)
const;
303 solveBlockMV(
const inverse_mv_type& X,
306 Teuchos::ETransp mode,
308 InverseScalar beta)
const;
311 std::vector<Teuchos::RCP<InverseCrs>> diagBlocks_;
314 mutable std::vector<inverse_mv_type> invX;
316 mutable std::vector<inverse_mv_type> invY;
325 mutable Teuchos::Array<Teuchos::RCP<InverseType>> Inverses_;
327 Teuchos::RCP<Teuchos::Comm<int>> localComm_;
331 Teuchos::ParameterList List_;
virtual void apply(ConstHostView X, HostView Y, int blockIndex, Teuchos::ETransp mode=Teuchos::NO_TRANS, SC alpha=Teuchos::ScalarTraits< SC >::one(), SC beta=Teuchos::ScalarTraits< SC >::zero()) const
Compute Y := alpha * M^{-1} X + beta*Y.
Definition Ifpack2_SparseContainer_def.hpp:168
virtual void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
Print the object with some verbosity level to the given FancyOStream.
Definition Ifpack2_SparseContainer_def.hpp:475
virtual void weightedApply(ConstHostView X, HostView Y, ConstHostView W, int blockIndex, Teuchos::ETransp mode=Teuchos::NO_TRANS, SC alpha=Teuchos::ScalarTraits< SC >::one(), SC beta=Teuchos::ScalarTraits< SC >::zero()) const
Compute Y := alpha * diag(D) * M^{-1} (diag(D) * X) + beta*Y.
Definition Ifpack2_SparseContainer_def.hpp:288