GooseFEM 1.4.1.dev2+g78f16df
Loading...
Searching...
No Matches
Matrix.h
Go to the documentation of this file.
1
7#ifndef GOOSEFEM_MATRIX_H
8#define GOOSEFEM_MATRIX_H
9
10#include "config.h"
11
12#include <Eigen/Eigen>
13#include <Eigen/Sparse>
14#include <Eigen/SparseCholesky>
15
16namespace GooseFEM {
17
18// forward declaration
19template <class>
20class MatrixSolver;
21
25template <class D>
27public:
31 using derived_type = D;
32
33private:
34 auto derived_cast() -> derived_type&
35 {
36 return *static_cast<derived_type*>(this);
37 }
38
39 auto derived_cast() const -> const derived_type&
40 {
41 return *static_cast<const derived_type*>(this);
42 }
43
44public:
52 template <class M>
54 {
55 GOOSEFEM_ASSERT(xt::has_shape(b, A.shape_nodevec()));
56 GOOSEFEM_ASSERT(xt::has_shape(x, A.shape_nodevec()));
57 derived_cast().solve_nodevec_impl(A, b, x);
58 }
59
67 template <class M>
69 {
70 GOOSEFEM_ASSERT(xt::has_shape(b, A.shape_dofval()));
71 GOOSEFEM_ASSERT(xt::has_shape(x, A.shape_dofval()));
72 derived_cast().solve_dofval_impl(A, b, x);
73 }
74};
75
79template <class D>
81public:
85 using derived_type = D;
86
87private:
88 auto derived_cast() -> derived_type&
89 {
90 return *static_cast<derived_type*>(this);
91 }
92
93 auto derived_cast() const -> const derived_type&
94 {
95 return *static_cast<const derived_type*>(this);
96 }
97
98public:
106 template <class M>
108 {
109 GOOSEFEM_ASSERT(xt::has_shape(b, A.shape_nodevec()));
110 array_type::tensor<double, 2> x = xt::empty_like(b);
111 derived_cast().solve_nodevec_impl(A, b, x);
112 return x;
113 }
114
122 template <class M>
124 {
125 GOOSEFEM_ASSERT(xt::has_shape(b, A.shape_dofval()));
126 array_type::tensor<double, 1> x = xt::empty_like(b);
127 derived_cast().solve_dofval_impl(A, b, x);
128 return x;
129 }
130};
131
135template <class D>
137public:
142
143private:
144 auto derived_cast() -> derived_type&
145 {
146 return *static_cast<derived_type*>(this);
147 }
148
149 auto derived_cast() const -> const derived_type&
150 {
151 return *static_cast<const derived_type*>(this);
152 }
153
154public:
163 template <class M>
164 array_type::tensor<double, 2>
166 {
167 GOOSEFEM_ASSERT(xt::has_shape(b, A.shape_nodevec()));
168 GOOSEFEM_ASSERT(xt::has_shape(x, A.shape_nodevec()));
170 derived_cast().solve_nodevec_impl(A, b, ret);
171 return ret;
172 }
173
182 template <class M>
185 {
186 GOOSEFEM_ASSERT(xt::has_shape(b, A.shape_dofval()));
187 GOOSEFEM_ASSERT(xt::has_shape(x, A.shape_dofval()));
189 derived_cast().solve_dofval_impl(A, b, ret);
190 return ret;
191 }
192};
193
197template <class D>
199protected:
202
203 size_t m_nelem;
204 size_t m_nne;
205 size_t m_nnode;
206 size_t m_ndim;
207 size_t m_ndof;
208
209 bool m_changed = true;
210
211public:
216
217private:
218 auto derived_cast() -> derived_type&
219 {
220 return *static_cast<derived_type*>(this);
221 }
222
223 auto derived_cast() const -> const derived_type&
224 {
225 return *static_cast<const derived_type*>(this);
226 }
227
228public:
233 size_t nelem() const
234 {
235 return derived_cast().m_nelem;
236 }
237
242 size_t nne() const
243 {
244 return derived_cast().m_nne;
245 }
246
251 size_t nnode() const
252 {
253 return derived_cast().m_nnode;
254 }
255
260 size_t ndim() const
261 {
262 return derived_cast().m_ndim;
263 }
264
269 size_t ndof() const
270 {
271 return derived_cast().m_ndof;
272 }
273
279 {
280 return derived_cast().m_dofs;
281 }
282
288 {
289 return derived_cast().m_conn;
290 }
291
296 std::array<size_t, 1> shape_dofval() const
297 {
298 return std::array<size_t, 1>{derived_cast().m_ndof};
299 }
300
305 std::array<size_t, 2> shape_nodevec() const
306 {
307 return std::array<size_t, 2>{derived_cast().m_nnode, derived_cast().m_ndim};
308 }
309
314 std::array<size_t, 3> shape_elemmat() const
315 {
316 return std::array<size_t, 3>{
317 derived_cast().m_nelem,
318 derived_cast().m_nne * derived_cast().m_ndim,
319 derived_cast().m_nne * derived_cast().m_ndim
320 };
321 }
322
327 template <class T>
328 void assemble(const T& elemmat)
329 {
330 GOOSEFEM_ASSERT(xt::has_shape(elemmat, this->shape_elemmat()));
331 derived_cast().assemble_impl(elemmat);
332 }
333
339 {
340 size_t ndof = derived_cast().m_ndof;
341 array_type::tensor<double, 2> ret = xt::empty<double>({ndof, ndof});
342 derived_cast().todense_impl(ret);
343 return ret;
344 }
345
350 template <class T>
351 void todense(T& ret) const
352 {
353 GOOSEFEM_ASSERT(xt::has_shape(ret, {derived_cast().m_ndof, derived_cast().m_ndof}));
354 derived_cast().todense_impl(ret);
355 }
356
364 {
365 GOOSEFEM_ASSERT(xt::has_shape(x, this->shape_nodevec()));
366 array_type::tensor<double, 2> b = xt::empty_like(x);
367 derived_cast().dot_nodevec_impl(x, b);
368 return b;
369 }
370
378 {
379 GOOSEFEM_ASSERT(xt::has_shape(x, this->shape_dofval()));
380 array_type::tensor<double, 1> b = xt::empty_like(x);
381 derived_cast().dot_dofval_impl(x, b);
382 return b;
383 }
384
392 {
393 GOOSEFEM_ASSERT(xt::has_shape(x, this->shape_nodevec()));
394 GOOSEFEM_ASSERT(xt::has_shape(b, this->shape_nodevec()));
395 derived_cast().dot_nodevec_impl(x, b);
396 }
397
405 {
406 GOOSEFEM_ASSERT(xt::has_shape(x, this->shape_dofval()));
407 GOOSEFEM_ASSERT(xt::has_shape(b, this->shape_dofval()));
408 derived_cast().dot_dofval_impl(x, b);
409 }
410};
411
415template <class D>
417protected:
420
421 size_t m_nnu;
422 size_t m_nnp;
423
424public:
429
430private:
431 auto derived_cast() -> derived_type&
432 {
433 return *static_cast<derived_type*>(this);
434 }
435
436 auto derived_cast() const -> const derived_type&
437 {
438 return *static_cast<const derived_type*>(this);
439 }
440
441public:
446 size_t nnu() const
447 {
448 return derived_cast().m_nnu;
449 }
450
455 size_t nnp() const
456 {
457 return derived_cast().m_nnp;
458 }
459
465 {
466 return derived_cast().m_iiu;
467 }
468
474 {
475 return derived_cast().m_iip;
476 }
477
491 {
492 GOOSEFEM_ASSERT(xt::has_shape(x, this->shape_nodevec()));
493 GOOSEFEM_ASSERT(xt::has_shape(b, this->shape_nodevec()));
495 derived_cast().reaction_nodevec_impl(x, ret);
496 return ret;
497 }
498
509 {
510 GOOSEFEM_ASSERT(xt::has_shape(x, this->shape_dofval()));
511 GOOSEFEM_ASSERT(xt::has_shape(b, this->shape_dofval()));
513 derived_cast().reaction_dofval_impl(x, ret);
514 return ret;
515 }
516
525 {
526 GOOSEFEM_ASSERT(xt::has_shape(x, this->shape_nodevec()));
527 GOOSEFEM_ASSERT(xt::has_shape(b, this->shape_nodevec()));
528 derived_cast().reaction_nodevec_impl(x, b);
529 }
530
539 {
540 GOOSEFEM_ASSERT(xt::has_shape(x, this->shape_dofval()));
541 GOOSEFEM_ASSERT(xt::has_shape(b, this->shape_dofval()));
542 derived_cast().reaction_dofval_impl(x, b);
543 }
544
556 ) const
557 {
558 array_type::tensor<double, 1> b_p = xt::empty<double>({m_nnp});
559 derived_cast().reaction_p_impl(x_u, x_p, b_p);
560 return b_p;
561 }
562
575 ) const
576 {
577 derived_cast().reaction_p_impl(x_u, x_p, b_p);
578 }
579};
580
584template <class D>
586protected:
589
590 size_t m_nni;
591 size_t m_nnd;
592
593public:
598
599private:
600 auto derived_cast() -> derived_type&
601 {
602 return *static_cast<derived_type*>(this);
603 }
604
605 auto derived_cast() const -> const derived_type&
606 {
607 return *static_cast<const derived_type*>(this);
608 }
609
610public:
615 size_t nni() const
616 {
617 return derived_cast().m_nni;
618 }
619
624 size_t nnd() const
625 {
626 return derived_cast().m_nnd;
627 }
628
634 {
635 return derived_cast().m_iii;
636 }
637
643 {
644 return derived_cast().m_iid;
645 }
646};
647
653class Matrix : public MatrixBase<Matrix> {
654private:
655 friend MatrixBase<Matrix>;
656
657private:
658 bool m_changed = true;
659
660 Eigen::SparseMatrix<double> m_A;
661
662 std::vector<Eigen::Triplet<double>> m_T;
663
667 template <class>
668 friend class MatrixSolver;
669
670public:
671 Matrix() = default;
672
680 {
681 m_conn = conn;
682 m_dofs = dofs;
683 m_nelem = m_conn.shape(0);
684 m_nne = m_conn.shape(1);
685 m_nnode = m_dofs.shape(0);
686 m_ndim = m_dofs.shape(1);
687 m_ndof = xt::amax(m_dofs)() + 1;
688 m_T.reserve(m_nelem * m_nne * m_ndim * m_nne * m_ndim);
689 m_A.resize(m_ndof, m_ndof);
690
691 GOOSEFEM_ASSERT(xt::amax(m_conn)() + 1 <= m_nnode);
693 }
694
698 const Eigen::SparseMatrix<double>& data() const
699 {
700 return m_A;
701 }
702
703private:
704 template <class T>
705 void assemble_impl(const T& elemmat)
706 {
707 m_T.clear();
708
709 for (size_t e = 0; e < m_nelem; ++e) {
710 for (size_t m = 0; m < m_nne; ++m) {
711 for (size_t i = 0; i < m_ndim; ++i) {
712 for (size_t n = 0; n < m_nne; ++n) {
713 for (size_t j = 0; j < m_ndim; ++j) {
714 m_T.push_back(Eigen::Triplet<double>(
715 m_dofs(m_conn(e, m), i),
716 m_dofs(m_conn(e, n), j),
717 elemmat(e, m * m_ndim + i, n * m_ndim + j)
718 ));
719 }
720 }
721 }
722 }
723 }
724
725 m_A.setFromTriplets(m_T.begin(), m_T.end());
726 m_changed = true;
727 }
728
729public:
737 void
741 {
742 GOOSEFEM_ASSERT(rows.size() == matrix.shape(0));
743 GOOSEFEM_ASSERT(cols.size() == matrix.shape(1));
744 GOOSEFEM_ASSERT(xt::amax(cols)() < m_ndof);
745 GOOSEFEM_ASSERT(xt::amax(rows)() < m_ndof);
746
747 std::vector<Eigen::Triplet<double>> T;
748
749 for (size_t i = 0; i < rows.size(); ++i) {
750 for (size_t j = 0; j < cols.size(); ++j) {
751 T.push_back(Eigen::Triplet<double>(rows(i), cols(j), matrix(i, j)));
752 }
753 }
754
755 m_A.setFromTriplets(T.begin(), T.end());
756 m_changed = true;
757 }
758
766 void
770 {
771 GOOSEFEM_ASSERT(rows.size() == matrix.shape(0));
772 GOOSEFEM_ASSERT(cols.size() == matrix.shape(1));
773 GOOSEFEM_ASSERT(xt::amax(cols)() < m_ndof);
774 GOOSEFEM_ASSERT(xt::amax(rows)() < m_ndof);
775
776 std::vector<Eigen::Triplet<double>> T;
777
778 Eigen::SparseMatrix<double> A(m_ndof, m_ndof);
779
780 for (size_t i = 0; i < rows.size(); ++i) {
781 for (size_t j = 0; j < cols.size(); ++j) {
782 T.push_back(Eigen::Triplet<double>(rows(i), cols(j), matrix(i, j)));
783 }
784 }
785
786 A.setFromTriplets(T.begin(), T.end());
787 m_A += A;
788 m_changed = true;
789 }
790
791private:
792 template <class T>
793 void todense_impl(T& ret) const
794 {
795 ret.fill(0.0);
796
797 for (int k = 0; k < m_A.outerSize(); ++k) {
798 for (Eigen::SparseMatrix<double>::InnerIterator it(m_A, k); it; ++it) {
799 ret(it.row(), it.col()) = it.value();
800 }
801 }
802 }
803
804 template <class T>
805 void dot_nodevec_impl(const T& x, T& b) const
806 {
807 this->Eigen_asNode_dofval_nodevec(m_A * this->Eigen_AsDofs_nodevec(x), b);
808 }
809
810 template <class T>
811 void dot_dofval_impl(const T& x, T& b) const
812 {
813 Eigen::Map<Eigen::VectorXd>(b.data(), b.size()).noalias() =
814 m_A * Eigen::Map<const Eigen::VectorXd>(x.data(), x.size());
815 }
816
817private:
824 template <class T>
825 Eigen::VectorXd Eigen_AsDofs_nodevec(const T& nodevec) const
826 {
827 GOOSEFEM_ASSERT(xt::has_shape(nodevec, {m_nnode, m_ndim}));
828
829 Eigen::VectorXd dofval = Eigen::VectorXd::Zero(m_ndof, 1);
830
831#pragma omp parallel for
832 for (size_t m = 0; m < m_nnode; ++m) {
833 for (size_t i = 0; i < m_ndim; ++i) {
834 dofval(m_dofs(m, i)) = nodevec(m, i);
835 }
836 }
837
838 return dofval;
839 }
840
847 template <class T>
848 void Eigen_asNode_dofval_nodevec(const Eigen::VectorXd& dofval, T& nodevec) const
849 {
850 GOOSEFEM_ASSERT(static_cast<size_t>(dofval.size()) == m_ndof);
851 GOOSEFEM_ASSERT(xt::has_shape(nodevec, {m_nnode, m_ndim}));
852
853#pragma omp parallel for
854 for (size_t m = 0; m < m_nnode; ++m) {
855 for (size_t i = 0; i < m_ndim; ++i) {
856 nodevec(m, i) = dofval(m_dofs(m, i));
857 }
858 }
859 }
860};
861
866template <class Solver = Eigen::SimplicialLDLT<Eigen::SparseMatrix<double>>>
867class MatrixSolver : public MatrixSolverBase<MatrixSolver<Solver>>,
868 public MatrixSolverSingleBase<MatrixSolver<Solver>> {
869private:
872
873public:
874 MatrixSolver() = default;
875
876private:
877 template <class T>
878 void solve_nodevec_impl(Matrix& A, const T& b, T& x)
879 {
880 this->factorize(A);
881 Eigen::VectorXd X = m_solver.solve(A.Eigen_AsDofs_nodevec(b));
882 A.Eigen_asNode_dofval_nodevec(X, x);
883 }
884
885 template <class T>
886 void solve_dofval_impl(Matrix& A, const T& b, T& x)
887 {
888 this->factorize(A);
889 Eigen::Map<Eigen::VectorXd>(x.data(), x.size()).noalias() =
890 m_solver.solve(Eigen::Map<const Eigen::VectorXd>(b.data(), A.m_ndof));
891 }
892
893private:
894 Solver m_solver;
895 bool m_factor = true;
896
900 void factorize(Matrix& A)
901 {
902 if (!A.m_changed && !m_factor) {
903 return;
904 }
905 m_solver.compute(A.m_A);
906 m_factor = false;
907 A.m_changed = false;
908 }
909};
910
911} // namespace GooseFEM
912
913#endif
CRTP base class for a matrix.
Definition Matrix.h:198
const array_type::tensor< size_t, 2 > & dofs() const
DOFs per node.
Definition Matrix.h:278
size_t nne() const
Number of nodes per element.
Definition Matrix.h:242
const array_type::tensor< size_t, 2 > & conn() const
Connectivity.
Definition Matrix.h:287
array_type::tensor< size_t, 2 > m_dofs
DOF-numbers per node [nnode, ndim].
Definition Matrix.h:201
size_t nnode() const
Number of nodes.
Definition Matrix.h:251
array_type::tensor< size_t, 2 > m_conn
Connectivity [nelem, nne].
Definition Matrix.h:200
std::array< size_t, 2 > shape_nodevec() const
Shape of "nodevec".
Definition Matrix.h:305
size_t m_nelem
See nelem().
Definition Matrix.h:203
array_type::tensor< double, 1 > Dot(const array_type::tensor< double, 1 > &x) const
Dot-product .
Definition Matrix.h:377
void dot(const array_type::tensor< double, 1 > &x, array_type::tensor< double, 1 > &b) const
Dot-product .
Definition Matrix.h:404
void assemble(const T &elemmat)
Assemble from "elemmat".
Definition Matrix.h:328
std::array< size_t, 3 > shape_elemmat() const
Shape of "elemmat".
Definition Matrix.h:314
array_type::tensor< double, 2 > Dot(const array_type::tensor< double, 2 > &x) const
Dot-product .
Definition Matrix.h:363
size_t m_nne
See nne().
Definition Matrix.h:204
size_t nelem() const
Number of elements.
Definition Matrix.h:233
bool m_changed
Signal changes to data.
Definition Matrix.h:209
size_t ndim() const
Number of dimensions.
Definition Matrix.h:260
array_type::tensor< double, 2 > Todense() const
Copy as dense matrix.
Definition Matrix.h:338
std::array< size_t, 1 > shape_dofval() const
Shape of "dofval".
Definition Matrix.h:296
size_t m_nnode
See nnode().
Definition Matrix.h:205
size_t m_ndim
See ndim().
Definition Matrix.h:206
size_t ndof() const
Number of DOFs.
Definition Matrix.h:269
void todense(T &ret) const
Copy to dense matrix.
Definition Matrix.h:351
D derived_type
Underlying type.
Definition Matrix.h:215
void dot(const array_type::tensor< double, 2 > &x, array_type::tensor< double, 2 > &b) const
Dot-product .
Definition Matrix.h:391
size_t m_ndof
See ndof().
Definition Matrix.h:207
CRTP base class for a partitioned matrix.
Definition Matrix.h:416
const array_type::tensor< size_t, 1 > & iiu() const
Unknown DOFs.
Definition Matrix.h:464
array_type::tensor< size_t, 1 > m_iiu
See iiu()
Definition Matrix.h:418
void reaction(const array_type::tensor< double, 1 > &x, array_type::tensor< double, 1 > &b) const
Same as Reaction(const array_type::tensor<double, 1>&, const array_type::tensor<double,...
Definition Matrix.h:538
size_t nnu() const
Number of unknown DOFs.
Definition Matrix.h:446
size_t nnp() const
Number of prescribed DOFs.
Definition Matrix.h:455
D derived_type
Underlying type.
Definition Matrix.h:428
array_type::tensor< size_t, 1 > m_iip
See iip()
Definition Matrix.h:419
const array_type::tensor< size_t, 1 > & iip() const
Prescribed DOFs.
Definition Matrix.h:473
void reaction_p(const array_type::tensor< double, 1 > &x_u, const array_type::tensor< double, 1 > &x_p, array_type::tensor< double, 1 > &b_p) const
Same as Reaction_p(const array_type::tensor<double, 1>&, const array_type::tensor<double,...
Definition Matrix.h:571
array_type::tensor< double, 1 > Reaction(const array_type::tensor< double, 1 > &x, const array_type::tensor< double, 1 > &b) const
Same as Reaction(const array_type::tensor<double, 2>&, const array_type::tensor<double,...
Definition Matrix.h:508
void reaction(const array_type::tensor< double, 2 > &x, array_type::tensor< double, 2 > &b) const
Same as Reaction(const array_type::tensor<double, 2>&, const array_type::tensor<double,...
Definition Matrix.h:524
array_type::tensor< double, 1 > Reaction_p(const array_type::tensor< double, 1 > &x_u, const array_type::tensor< double, 1 > &x_p) const
Same as Reaction(const array_type::tensor<double, 1>&, const array_type::tensor<double,...
Definition Matrix.h:553
array_type::tensor< double, 2 > Reaction(const array_type::tensor< double, 2 > &x, const array_type::tensor< double, 2 > &b) const
Right-hand-size for corresponding to the prescribed DOFs:
Definition Matrix.h:490
CRTP base class for a partitioned matrix with tying.
Definition Matrix.h:585
array_type::tensor< size_t, 1 > m_iii
See iii()
Definition Matrix.h:587
array_type::tensor< size_t, 1 > m_iid
See iid()
Definition Matrix.h:588
size_t nnd() const
Number of dependent DOFs.
Definition Matrix.h:624
size_t nni() const
Number of independent DOFs.
Definition Matrix.h:615
const array_type::tensor< size_t, 1 > & iii() const
Independent DOFs.
Definition Matrix.h:633
const array_type::tensor< size_t, 1 > & iid() const
Dependent DOFs.
Definition Matrix.h:642
CRTP base class for a solver class.
Definition Matrix.h:26
void solve(M &A, const array_type::tensor< double, 2 > &b, array_type::tensor< double, 2 > &x)
Solve .
Definition Matrix.h:53
void solve(M &A, const array_type::tensor< double, 1 > &b, array_type::tensor< double, 1 > &x)
Solve .
Definition Matrix.h:68
D derived_type
Underlying type.
Definition Matrix.h:31
CRTP base class for a extra functions for a partitioned solver class.
Definition Matrix.h:136
array_type::tensor< double, 1 > Solve(M &A, const array_type::tensor< double, 1 > &b, const array_type::tensor< double, 1 > &x)
Solve .
Definition Matrix.h:184
array_type::tensor< double, 2 > Solve(M &A, const array_type::tensor< double, 2 > &b, const array_type::tensor< double, 2 > &x)
Solve .
Definition Matrix.h:165
CRTP base class for a solver class.
Definition Matrix.h:80
array_type::tensor< double, 2 > Solve(M &A, const array_type::tensor< double, 2 > &b)
Solve .
Definition Matrix.h:107
array_type::tensor< double, 1 > Solve(M &A, const array_type::tensor< double, 1 > &b)
Solve .
Definition Matrix.h:123
D derived_type
Underlying type.
Definition Matrix.h:85
Solve , for A of the GooseFEM::Matrix() class.
Definition Matrix.h:868
Sparse matrix.
Definition Matrix.h:653
Matrix(const array_type::tensor< size_t, 2 > &conn, const array_type::tensor< size_t, 2 > &dofs)
Constructor.
Definition Matrix.h:679
const Eigen::SparseMatrix< double > & data() const
Pointer to data.
Definition Matrix.h:698
void add(const array_type::tensor< size_t, 1 > &rows, const array_type::tensor< size_t, 1 > &cols, const array_type::tensor< double, 2 > &matrix)
Add matrix.
Definition Matrix.h:767
void set(const array_type::tensor< size_t, 1 > &rows, const array_type::tensor< size_t, 1 > &cols, const array_type::tensor< double, 2 > &matrix)
Overwrite matrix.
Definition Matrix.h:738
Basic configuration:
#define GOOSEFEM_ASSERT(expr)
All assertions are implementation as::
Definition config.h:97
xt::xtensor< T, N > tensor
Fixed (static) rank array.
Definition config.h:177
Toolbox to perform finite element computations.
Definition Allocate.h:14
auto AsTensor(const T &arg, const S &shape)
"Broadcast" a scalar stored in an array (e.g.
Definition Allocate.h:167