/* Copyright 2013 SINTEF ICT, Applied Mathematics. This file is part of the Open Porous Media project (OPM). OPM is free software: you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. OPM is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. You should have received a copy of the GNU General Public License along with OPM. If not, see . */ #ifndef OPM_AUTODIFFHELPERS_HEADER_INCLUDED #define OPM_AUTODIFFHELPERS_HEADER_INCLUDED #include #include #include #include #include namespace Opm { // -------------------- class HelperOps -------------------- /// Contains vectors and sparse matrices that represent subsets or /// operations on (AD or regular) vectors of data. struct HelperOps { typedef AutoDiffBlock::M M; typedef AutoDiffBlock::V V; /// A list of internal faces. typedef Eigen::Array IFaces; IFaces internal_faces; /// Extract for each internal face the difference of its adjacent cells' values (first - second). M ngrad; /// Extract for each face the difference of its adjacent cells' values (second - first). M grad; /// Extract for each face the average of its adjacent cells' values. M caver; /// Extract for each cell the sum of its adjacent interior faces' (signed) values. M div; /// Extract for each face the difference of its adjacent cells' values (first - second). /// For boundary faces, one of the entries per row (corresponding to the outside) is zero. M fullngrad; /// Extract for each cell the sum of all its adjacent faces' (signed) values. M fulldiv; /// Constructs all helper vectors and matrices. HelperOps(const UnstructuredGrid& grid) { const int nc = grid.number_of_cells; const int nf = grid.number_of_faces; // Define some neighbourhood-derived helper arrays. typedef Eigen::Array OneColBool; typedef Eigen::Array TwoColInt; typedef Eigen::Array TwoColBool; TwoColInt nb = Eigen::Map(grid.face_cells, nf, 2); // std::cout << "nb = \n" << nb << std::endl; TwoColBool nbib = nb >= 0; OneColBool ifaces = nbib.rowwise().all(); const int num_internal = ifaces.cast().sum(); // std::cout << num_internal << " internal faces." << std::endl; TwoColInt nbi(num_internal, 2); internal_faces.resize(num_internal); int fi = 0; for (int f = 0; f < nf; ++f) { if (ifaces[f]) { internal_faces[fi] = f; nbi.row(fi) = nb.row(f); ++fi; } } // std::cout << "nbi = \n" << nbi << std::endl; // Create matrices. ngrad.resize(num_internal, nc); caver.resize(num_internal, nc); typedef Eigen::Triplet Tri; std::vector ngrad_tri; std::vector caver_tri; ngrad_tri.reserve(2*num_internal); caver_tri.reserve(2*num_internal); for (int i = 0; i < num_internal; ++i) { ngrad_tri.emplace_back(i, nbi(i,0), 1.0); ngrad_tri.emplace_back(i, nbi(i,1), -1.0); caver_tri.emplace_back(i, nbi(i,0), 0.5); caver_tri.emplace_back(i, nbi(i,1), 0.5); } ngrad.setFromTriplets(ngrad_tri.begin(), ngrad_tri.end()); caver.setFromTriplets(caver_tri.begin(), caver_tri.end()); grad = -ngrad; div = ngrad.transpose(); std::vector fullngrad_tri; fullngrad_tri.reserve(2*nf); for (int i = 0; i < nf; ++i) { if (nb(i,0) >= 0) { fullngrad_tri.emplace_back(i, nb(i,0), 1.0); } if (nb(i,1) >= 0) { fullngrad_tri.emplace_back(i, nb(i,1), -1.0); } } fullngrad.resize(nf, nc); fullngrad.setFromTriplets(fullngrad_tri.begin(), fullngrad_tri.end()); fulldiv = fullngrad.transpose(); } }; // -------------------- upwinding helper class -------------------- /// Upwind selection in absence of counter-current flow (i.e., /// without effects of gravity and/or capillary pressure). template class UpwindSelector { public: typedef AutoDiffBlock ADB; UpwindSelector(const UnstructuredGrid& g, const HelperOps& h, const typename ADB::V& ifaceflux) { typedef HelperOps::IFaces::Index IFIndex; const IFIndex nif = h.internal_faces.size(); assert(nif == ifaceflux.size()); // Define selector structure. typedef typename Eigen::Triplet Triplet; std::vector s; s.reserve(nif); for (IFIndex iface = 0; iface < nif; ++iface) { const int f = h.internal_faces[iface]; const int c1 = g.face_cells[2*f + 0]; const int c2 = g.face_cells[2*f + 1]; assert ((c1 >= 0) && (c2 >= 0)); // Select upwind cell. const int c = (ifaceflux[iface] >= 0) ? c1 : c2; s.push_back(Triplet(iface, c, Scalar(1))); } // Assemble explicit selector operator. select_.resize(nif, g.number_of_cells); select_.setFromTriplets(s.begin(), s.end()); } /// Apply selector to multiple per-cell quantities. std::vector select(const std::vector& xc) const { // Absence of counter-current flow means that the same // selector applies to all quantities, 'x', defined per // cell. std::vector xf; xf.reserve(xc.size()); for (typename std::vector::const_iterator b = xc.begin(), e = xc.end(); b != e; ++b) { xf.push_back(select_ * (*b)); } return xf; } /// Apply selector to single per-cell ADB quantity. ADB select(const ADB& xc) const { return select_*xc; } /// Apply selector to single per-cell constant quantity. typename ADB::V select(const typename ADB::V& xc) const { return (select_*xc.matrix()).array(); } private: typename ADB::M select_; }; namespace { template Eigen::SparseMatrix constructSubsetSparseMatrix(const int full_size, const IntVec& indices) { typedef Eigen::Triplet Tri; const int subset_size = indices.size(); std::vector triplets(subset_size); for (int i = 0; i < subset_size; ++i) { triplets[i] = Tri(i, indices[i], 1); } Eigen::SparseMatrix sub(subset_size, full_size); sub.setFromTriplets(triplets.begin(), triplets.end()); return sub; } template Eigen::SparseMatrix constructSupersetSparseMatrix(const int full_size, const IntVec& indices) { return constructSubsetSparseMatrix(full_size, indices).transpose(); } } // anon namespace /// Returns x(indices). template AutoDiffBlock subset(const AutoDiffBlock& x, const IntVec& indices) { return constructSubsetSparseMatrix(x.value().size(), indices) * x; } /// Returns x(indices). template Eigen::Array subset(const Eigen::Array& x, const IntVec& indices) { return (constructSubsetSparseMatrix(x.size(), indices) * x.matrix()).array(); } /// Returns v where v(indices) == x, v(!indices) == 0 and v.size() == n. template AutoDiffBlock superset(const AutoDiffBlock& x, const IntVec& indices, const int n) { return constructSupersetSparseMatrix(n, indices) * x; } /// Returns v where v(indices) == x, v(!indices) == 0 and v.size() == n. template Eigen::Array superset(const Eigen::Array& x, const IntVec& indices, const int n) { return constructSupersetSparseMatrix(n, indices) * x.matrix(); } /// Construct square sparse matrix with the /// elements of d on the diagonal. /// Need to mark this as inline since it is defined in a header and not a template. inline AutoDiffBlock::M spdiag(const AutoDiffBlock::V& d) { typedef AutoDiffBlock::M M; const int n = d.size(); M mat(n, n); mat.reserve(Eigen::ArrayXi::Ones(n, 1)); for (M::Index i = 0; i < n; ++i) { mat.insert(i, i) = d[i]; } return mat; } /// Selection. Choose first of two elements if selection basis element is nonnegative. template class Selector { public: typedef AutoDiffBlock ADB; Selector(const typename ADB::V& selection_basis) { // Define selector structure. const int n = selection_basis.size(); // Over-reserving so we do not have to count. left_elems_.reserve(n); right_elems_.reserve(n); for (int i = 0; i < n; ++i) { if (selection_basis[i] < 0.0) { right_elems_.push_back(i); } else { left_elems_.push_back(i); } } } /// Apply selector to ADB quantities. ADB select(const ADB& x1, const ADB& x2) const { if (right_elems_.empty()) { return x1; } else if (left_elems_.empty()) { return x2; } else { return superset(subset(x1, left_elems_), left_elems_, x1.size()) + superset(subset(x2, right_elems_), right_elems_, x2.size()); } } /// Apply selector to ADB quantities. typename ADB::V select(const typename ADB::V& x1, const typename ADB::V& x2) const { if (right_elems_.empty()) { return x1; } else if (left_elems_.empty()) { return x2; } else { return superset(subset(x1, left_elems_), left_elems_, x1.size()) + superset(subset(x2, right_elems_), right_elems_, x2.size()); } } private: std::vector left_elems_; std::vector right_elems_; }; /// Returns the input expression, but with all Jacobians collapsed to one. inline AutoDiffBlock collapseJacs(const AutoDiffBlock& x) { typedef AutoDiffBlock ADB; const int nb = x.numBlocks(); typedef Eigen::Triplet Tri; int nnz = 0; for (int block = 0; block < nb; ++block) { nnz += x.derivative()[block].nonZeros(); } std::vector t; t.reserve(nnz); int block_col_start = 0; for (int block = 0; block < nb; ++block) { const ADB::M& jac = x.derivative()[block]; for (ADB::M::Index k = 0; k < jac.outerSize(); ++k) { for (ADB::M::InnerIterator i(jac, k); i ; ++i) { t.push_back(Tri(i.row(), i.col() + block_col_start, i.value())); } } block_col_start += jac.cols(); } // Build final jacobian. std::vector jacs(1); jacs[0].resize(x.size(), block_col_start); jacs[0].setFromTriplets(t.begin(), t.end()); return ADB::function(x.value(), jacs); } /// Returns the vertical concatenation [ x; y ] of the inputs. inline AutoDiffBlock vertcat(const AutoDiffBlock& x, const AutoDiffBlock& y) { const int nx = x.size(); const int ny = y.size(); const int n = nx + ny; std::vector xind(nx); for (int i = 0; i < nx; ++i) { xind[i] = i; } std::vector yind(ny); for (int i = 0; i < ny; ++i) { yind[i] = nx + i; } return superset(x, xind, n) + superset(y, yind, n); } class Span { public: explicit Span(const int num) : num_(num), stride_(1), start_(0) { } Span(const int num, const int stride, const int start) : num_(num), stride_(stride), start_(start) { } int operator[](const int i) const { assert(i >= 0 && i < num_); return start_ + i*stride_; } int size() const { return num_; } class SpanIterator { public: SpanIterator(const Span* span, const int index) : span_(span), index_(index) { } SpanIterator operator++() { ++index_; return *this; } SpanIterator operator++(int) { SpanIterator before_increment(*this); ++index_; return before_increment; } bool operator<(const SpanIterator& rhs) const { assert(span_ == rhs.span_); return index_ < rhs.index_; } bool operator==(const SpanIterator& rhs) const { assert(span_ == rhs.span_); return index_ == rhs.index_; } bool operator!=(const SpanIterator& rhs) const { assert(span_ == rhs.span_); return index_ != rhs.index_; } int operator*() { return (*span_)[index_]; } private: const Span* span_; int index_; }; typedef SpanIterator iterator; typedef SpanIterator const_iterator; SpanIterator begin() const { return SpanIterator(this, 0); } SpanIterator end() const { return SpanIterator(this, num_); } bool operator==(const Span& rhs) { return num_ == rhs.num_ && start_ == rhs.start_ && stride_ == rhs.stride_; } private: const int num_; const int stride_; const int start_; }; /// Return a vector of (-1.0, 0.0 or 1.0), depending on sign per element. inline Eigen::ArrayXd sign (const Eigen::ArrayXd& x) { const int n = x.size(); Eigen::ArrayXd retval(n); for (int i = 0; i < n; ++i) { retval[i] = x[i] < 0.0 ? -1.0 : (x[i] > 0.0 ? 1.0 : 0.0); } return retval; } } // namespace Opm #endif // OPM_AUTODIFFHELPERS_HEADER_INCLUDED