Home
last modified time | relevance | path

Searched refs:FullMatrix (Results 1 – 25 of 281) sorted by relevance

12345678910>>...12

/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/source/lac/
H A Dfull_matrix.inst.in85 template FullMatrix<S1> &FullMatrix<S1>::operator=(
117 template void FullMatrix<S1>::mmult<S2>(FullMatrix<S2> &,
120 template void FullMatrix<S1>::Tmmult<S2>(FullMatrix<S2> &,
123 template void FullMatrix<S1>::mTmult<S2>(FullMatrix<S2> &,
126 template void FullMatrix<S1>::TmTmult<S2>(FullMatrix<S2> &,
129 template void FullMatrix<S1>::invert<S2>(const FullMatrix<S2> &);
131 template void FullMatrix<S1>::left_invert<S2>(const FullMatrix<S2> &);
139 template void FullMatrix<S1>::cholesky<S2>(const FullMatrix<S2> &);
237 template void FullMatrix<S1>::mmult<S2>(FullMatrix<S2> &,
240 template void FullMatrix<S1>::Tmmult<S2>(FullMatrix<S2> &,
[all …]
H A Dfull_matrix.cc29 template class FullMatrix<std::complex<double>>; variable
34 template class FullMatrix<long double>; variable
36 FullMatrix<long double>::invert<long double>(const FullMatrix<long double> &);
38 FullMatrix<long double>::mmult<long double>(FullMatrix<long double> &,
42 FullMatrix<long double>::Tmmult<long double>(FullMatrix<long double> &,
46 FullMatrix<long double>::mTmult<long double>(FullMatrix<long double> &,
50 FullMatrix<long double>::TmTmult<long double>(FullMatrix<long double> &,
54 FullMatrix<long double>::vmult<long double>(Vector<long double> &,
58 FullMatrix<long double>::Tvmult<long double>(Vector<long double> &,
62 FullMatrix<long double>::add<long double>(const long double,
[all …]
H A Dpetsc_full_matrix.cc27 FullMatrix::FullMatrix() in FullMatrix() function in PETScWrappers::FullMatrix
33 FullMatrix::FullMatrix(const size_type m, const size_type n) in FullMatrix() function in PETScWrappers::FullMatrix
39 FullMatrix::reinit(const size_type m, const size_type n) in reinit()
50 FullMatrix::do_reinit(const size_type m, const size_type n) in do_reinit()
61 FullMatrix::get_mpi_communicator() const in get_mpi_communicator()
H A Daffine_constraints.inst.in86 const FullMatrix<S> &,
95 const FullMatrix<S> &,
105 const FullMatrix<S> &,
114 const FullMatrix<S> &,
120 const FullMatrix<S> &,
138 const FullMatrix<S> &,
155 const FullMatrix<S> &,
218 const FullMatrix<S> &,
225 const FullMatrix<S> &,
238 const FullMatrix<S> &,
[all …]
H A Daffine_constraints.cc44 const FullMatrix<VectorType::value_type> &) const; \
52 const FullMatrix<VectorType::value_type> &, \
58 const FullMatrix<MatrixType::value_type> &, \
69 const FullMatrix<MatrixType::value_type> &, \
80 MatrixType>(const FullMatrix<MatrixType::value_type> &, \
86 MatrixType>(const FullMatrix<MatrixType::value_type> &, \
/dports/math/hmat-oss/hmat-oss-1.7.1/src/
H A Dfull_matrix.cpp67 FullMatrix<T>::FullMatrix(T* _m, const IndexSet* _rows, const IndexSet* _cols, int _lda) in FullMatrix() function in hmat::FullMatrix
75 FullMatrix<T>::FullMatrix(ScalarArray<T> *s, const IndexSet* _rows, const IndexSet* _cols) in FullMatrix() function in hmat::FullMatrix
86 FullMatrix<T>::FullMatrix(const IndexSet* _rows, const IndexSet* _cols, bool zeroinit) in FullMatrix() function in hmat::FullMatrix
93 template<typename T> FullMatrix<T>::~FullMatrix() { in ~FullMatrix()
131 template<typename T> FullMatrix<T>* FullMatrix<T>::copy(FullMatrix<T>* result) const { in copy()
149 template<typename T> FullMatrix<T>* FullMatrix<T>::copyAndTranspose() const { in copyAndTranspose()
152 FullMatrix<T>* result = new FullMatrix<T>(cols_, rows_); in copyAndTranspose()
157 template<typename T> const FullMatrix<T>* FullMatrix<T>::subset(const IndexSet* subRows, in subset()
171 const FullMatrix<T>* a, const FullMatrix<T>* b, in gemm()
276 void FullMatrix<T>::copyMatrixAtOffset(const FullMatrix<T>* a, in copyMatrixAtOffset()
[all …]
H A Dfull_matrix.hpp44 template<typename T> class FullMatrix { class
53 FullMatrix(const FullMatrix<T>& o);
76 FullMatrix(T* _m, const IndexSet* _rows, const IndexSet* _cols, int _lda=-1);
85 FullMatrix(ScalarArray<T> *s, const IndexSet* _rows, const IndexSet* _cols);
93 FullMatrix(const IndexSet* _rows, const IndexSet* _cols, bool zeroinit=true);
94 ~FullMatrix();
129 FullMatrix<T>* copy(FullMatrix<T>* result = NULL) const;
132 FullMatrix<T>* copyAndTranspose() const;
154 void gemm(char transA, char transB, T alpha, const FullMatrix<T>* a,
155 const FullMatrix<T>* b, T beta);
[all …]
H A Dfromdouble.cpp57 FullMatrix<D_t>* fromDoubleFull(FullMatrix<D_t>* f) { in fromDoubleFull()
61 FullMatrix<Z_t>* fromDoubleFull(FullMatrix<Z_t>* f) { in fromDoubleFull()
66 FullMatrix<T>* fromDoubleFull(FullMatrix<typename Types<T>::dp>* f) { in fromDoubleFull()
69 FullMatrix<T>* result = new FullMatrix<T>(f->rows_, f->cols_); in fromDoubleFull()
78 template FullMatrix<S_t>* fromDoubleFull(FullMatrix<Types<S_t>::dp>* f);
79 template FullMatrix<C_t>* fromDoubleFull(FullMatrix<Types<C_t>::dp>* f);
H A Dh_matrix.hpp51 template<typename T> class FullMatrix;
134 FullMatrix<T> * full_;
160 void axpy(T alpha, const FullMatrix<T>* b);
258 …void gemv(char trans, T alpha, const FullMatrix<T>* x, T beta, FullMatrix<T>* y, Side side = Side:…
426 FullMatrix<T>* getFullMatrix() const { in getFullMatrix()
505 void solveDiagonal(FullMatrix<T>* b) const;
511 void solve(FullMatrix<T>* b) const;
528 void solveLdlt(FullMatrix<T>* b) const ;
534 void solveLlt(FullMatrix<T>* b) const ;
658 FullMatrix<T> * full() const { in full()
[all …]
H A Dassembly.hpp34 template<typename T> class FullMatrix;
64 FullMatrix<T> * & fullMatrix, RkMatrix<T> * & rkMatrix,
79 FullMatrix<T> * & fullMatrix, RkMatrix<T> * & rkMatrix,
91 virtual FullMatrix<typename Types<T>::dp>* assemble(const ClusterData* rows,
180 virtual FullMatrix<typename Types<T>::dp>* assemble(const ClusterData* rows,
213 FullMatrix<typename Types<T>::dp>* assemble(const ClusterData* rows,
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/include/deal.II/lac/
H A Dfull_matrix.h171 FullMatrix<number> &
181 FullMatrix<number> &
192 FullMatrix<number> &
200 FullMatrix<number> &
555 FullMatrix &
561 FullMatrix &
585 const FullMatrix<number2> &A,
600 const FullMatrix<number2> &A,
1111 FullMatrix<number>::m() const in m()
1120 FullMatrix<number>::n() const in n()
[all …]
H A Dfull_matrix.templates.h46 FullMatrix<number>::FullMatrix(const size_type n) in FullMatrix() function
58 FullMatrix<number>::FullMatrix(const size_type m, in FullMatrix() function
69 FullMatrix<number>::FullMatrix(const IdentityMatrix &id) in FullMatrix() function
81 FullMatrix<number>::operator=(const FullMatrix<number2> &M)
307 FullMatrix<number>::fill(const FullMatrix<number2> &src, in fill()
507 FullMatrix<number>::mmult(FullMatrix<number2> & dst, in mmult()
589 FullMatrix<number>::Tmmult(FullMatrix<number2> & dst, in Tmmult()
694 FullMatrix<number>::mTmult(FullMatrix<number2> & dst, in mTmult()
1122 FullMatrix<number>::add(const FullMatrix<number2> &src, in add()
1149 FullMatrix<number>::Tadd(const FullMatrix<number2> &src, in Tadd()
[all …]
H A Dprecondition_block_base.h37 class FullMatrix; variable
166 FullMatrix<number> &
184 const FullMatrix<number> &
202 FullMatrix<number> &
208 const FullMatrix<number> &
380 std::vector<FullMatrix<number>> tmp(n, FullMatrix<number>(b)); in reinit()
388 std::vector<FullMatrix<number>> tmp(n, FullMatrix<number>(b)); in reinit()
475 inline const FullMatrix<number> &
511 inline const FullMatrix<number> &
525 inline FullMatrix<number> &
[all …]
/dports/science/ergo/ergo-3.8/source/dft/
H A Dxc_matrix.cc268 Dft::FullMatrix res(nbast); in dft_get_xc()
269 Dft::FullMatrix density(dmat, nbast); in dft_get_xc()
287 &xcCallbackLdaR<Dft::FullMatrix,XCDistributorLda<Dft::FullMatrix> >; in dft_get_xc()
291 &xcCallbackGgaR<Dft::FullMatrix,XCDistributorGga<Dft::FullMatrix> >; in dft_get_xc()
439 Dft::FullMatrix *exca, *excb;
454 const Dft::FullMatrix *dmat[2]; in dft_get_uxc()
457 Dft::FullMatrix mata(nbast), matb(nbast); in dft_get_uxc()
458 Dft::FullMatrix densa(dmata, nbast); in dft_get_uxc()
459 Dft::FullMatrix densb(dmatb, nbast); in dft_get_uxc()
470 = xcCallbackLdaU<Dft::FullMatrix,XCDistributorLda<Dft::FullMatrix> >; in dft_get_uxc()
[all …]
H A Dgrid_matrix.h53 class FullMatrix {
58 explicit FullMatrix(int nbast_) in FullMatrix() function
63 FullMatrix(ergo_real *m, int nbast_) in FullMatrix() function
68 FullMatrix(const ergo_real *m, int nbast_) in FullMatrix() function
73 ~FullMatrix() { if (owned && mat) delete []mat; } in ~FullMatrix()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/include/deal.II/fe/
H A Dfe_q_hierarchical.h588 FullMatrix<double> & matrix) const override;
593 virtual const FullMatrix<double> &
652 FullMatrix<double> & matrix,
670 FullMatrix<double> & matrix,
751 build_dofs_cell(std::vector<FullMatrix<double>> &dofs_cell,
752 std::vector<FullMatrix<double>> &dofs_subcell) const;
759 initialize_constraints(const std::vector<FullMatrix<double>> &dofs_subcell);
766 const std::vector<FullMatrix<double>> &dofs_cell,
767 const std::vector<FullMatrix<double>> &dofs_subcell);
H A Dfe_bernstein.h81 FullMatrix<double> &matrix) const override;
90 virtual const FullMatrix<double> &
103 virtual const FullMatrix<double> &
120 FullMatrix<double> & matrix,
136 FullMatrix<double> & matrix,
H A Dfe_q_base.h61 FullMatrix<double> &matrix) const override;
75 FullMatrix<double> & matrix,
91 FullMatrix<double> & matrix,
124 virtual const FullMatrix<double> &
156 virtual const FullMatrix<double> &
H A Dfe_tools.h45 class FullMatrix; variable
196 FullMatrix<number> &interpolation_matrix);
239 FullMatrix<number> & matrix);
310 FullMatrix<double>
355 std::vector<std::vector<FullMatrix<number>>> &matrices,
424 std::vector<std::vector<FullMatrix<number>>> &matrices,
518 FullMatrix<double> & X);
532 FullMatrix<double> & I_q);
550 const FullMatrix<double> & projection_matrix,
562 const FullMatrix<double> & projection_matrix,
[all …]
/dports/biology/mothur/mothur-1.46.1/source/datastructures/
H A Dfullmatrix.cpp14 FullMatrix::FullMatrix(ifstream& filehandle, GroupMap* g, bool s) : groupmap(g), sim(s) { in FullMatrix() function in FullMatrix
73 int FullMatrix::readSquareMatrix(ifstream& filehandle) { in readSquareMatrix()
113 int FullMatrix::readLTMatrix(ifstream& filehandle) { in readLTMatrix()
156 void FullMatrix::sortGroups(int low, int high){ in sortGroups()
198 void FullMatrix::swapRows(int i, int j) { in swapRows()
236 float FullMatrix::get(int i, int j){ return matrix[i][j]; } in get()
240 vector<string> FullMatrix::getGroups(){ return groups; } in getGroups()
244 vector<int> FullMatrix::getSizes(){ return sizes; } in getSizes()
248 int FullMatrix::getNumGroups(){ return groups.size(); } in getNumGroups()
252 int FullMatrix::getNumSeqs(){ return numSeqs; } in getNumSeqs()
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/source/fe/
H A Dfe_tools.inst.in155 FullMatrix<double> &);
166 FullMatrix<double> &);
173 FullMatrix<double> &);
192 FullMatrix<double> &);
197 FullMatrix<double> &);
202 FullMatrix<float> &);
207 FullMatrix<float> &);
212 FullMatrix<float> &);
218 FullMatrix<double> &);
223 FullMatrix<float> &);
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/include/deal.II/physics/
H A Dnotation.h399 FullMatrix<Number>
409 FullMatrix<Number>
419 FullMatrix<Number>
429 FullMatrix<Number>
443 FullMatrix<Number>
482 FullMatrix<Number>
493 FullMatrix<Number>
505 FullMatrix<Number>
892 FullMatrix<Number>
902 FullMatrix<Number>
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/include/deal.II/differentiation/ad/
H A Dad_drivers.h446 FullMatrix<ScalarType> & hessian) const;
495 FullMatrix<ScalarType> & jacobian) const;
629 FullMatrix<ScalarType> & hessian) const;
859 FullMatrix<scalar_type> & hessian) const;
878 FullMatrix<scalar_type> & jacobian) const;
1055 FullMatrix<scalar_type> &) const;
1074 FullMatrix<scalar_type> &) const;
1178 FullMatrix<scalar_type> & hessian) const;
1197 FullMatrix<scalar_type> & jacobian) const;
1279 FullMatrix<ScalarType> & hessian) const;
[all …]
/dports/science/votca/votca-2021.2-18560-gfbe18d971/xtp/src/tests/
H A Dtest_threecenter_dft.cc56 bool check_three1 = Ref0.isApprox(threec[0].FullMatrix(), 0.00001); in BOOST_AUTO_TEST_CASE()
59 std::cout << threec[0].FullMatrix() << std::endl; in BOOST_AUTO_TEST_CASE()
64 bool check_three2 = Ref4.isApprox(threec[4].FullMatrix(), 0.00001); in BOOST_AUTO_TEST_CASE()
67 std::cout << threec[4].FullMatrix() << std::endl; in BOOST_AUTO_TEST_CASE()
/dports/science/votca/votca-2021.2-18560-gfbe18d971/xtp/xtp-2a31d70/src/tests/
H A Dtest_threecenter_dft.cc56 bool check_three1 = Ref0.isApprox(threec[0].FullMatrix(), 0.00001); in BOOST_AUTO_TEST_CASE()
59 std::cout << threec[0].FullMatrix() << std::endl; in BOOST_AUTO_TEST_CASE()
64 bool check_three2 = Ref4.isApprox(threec[4].FullMatrix(), 0.00001); in BOOST_AUTO_TEST_CASE()
67 std::cout << threec[4].FullMatrix() << std::endl; in BOOST_AUTO_TEST_CASE()

12345678910>>...12