Home
last modified time | relevance | path

Searched refs:a_mat (Results 1 – 25 of 157) sorted by relevance

1234567

/dports/science/qmcpack/qmcpack-3.11.0/src/Utilities/tests/for_testing/
H A Dtest_checkMatrix.cpp20 Matrix<double> a_mat; variable
21 a_mat.resize(3, 3);
22 a_mat(0, 0) = 2.3;
23 a_mat(0, 1) = 4.5;
24 a_mat(0, 2) = 2.6;
25 a_mat(1, 0) = 0.5;
26 a_mat(1, 1) = 8.5;
27 a_mat(1, 2) = 3.3;
28 a_mat(2, 0) = 1.8;
29 a_mat(2, 1) = 4.4;
[all …]
/dports/science/qmcpack/qmcpack-3.11.0/src/Utilities/for_testing/
H A DcheckMatrix.hpp65 CheckMatrixResult checkMatrix(const Matrix<T1, ALLOC1>& a_mat, in checkMatrix() argument
70 if (a_mat.rows() > b_mat.rows() || a_mat.cols() > b_mat.cols()) in checkMatrix()
73 auto matrixElementError = [&error_msg](int i, int j, auto& a_mat, auto& b_mat) { in checkMatrix() argument
74 error_msg << "checkMatrix found bad element at " << i << ":" << j << " " << a_mat(i, j) in checkMatrix()
78 for (int i = 0; i < a_mat.rows(); i++) in checkMatrix()
79 for (int j = 0; j < a_mat.cols(); j++) in checkMatrix()
81 bool approx_equality = approxEquality<T1>(a_mat(i, j), b_mat(i, j)); in checkMatrix()
84 matrixElementError(i, j, a_mat, b_mat); in checkMatrix()
/dports/math/elpa/elpa-2019.05.002/src/elpa2/
H A Delpa2_bandred_template.F90649 a_mat(lr,lch) = vrl
710 a_mat(1:lr,lcx) = a_mat(1:lr,lcx) - conjg(tau)*aux2(nlc)*vr(1:lr)
728 a_mat(1:lr,lcx) = a_mat(1:lr,lcx) - conjg(tau)*aux1(nlc)*vr(1:lr)
797 a_mat(ii+pp,lcx) = a_mat(ii+pp,lcx) - tau*aux2(mynlc)*vr(ii+pp)
800 a_mat(ii+pp,lcx) = a_mat(ii+pp,lcx) - conjg(tau)*aux2(mynlc)*vr(ii+pp)
836 a_mat(1:lr,lcx) = a_mat(1:lr,lcx) - tau*aux2(nlc)*vr(1:lr)
839 a_mat(1:lr,lcx) = a_mat(1:lr,lcx) - conjg(tau)*aux2(nlc)*vr(1:lr)
1062 ONE, a_mat(lrs,lcs), ubound(a_mat,dim=1), &
1073 ONE, a_mat(1,lcs), ubound(a_mat,dim=1), &
1153 lce-lcs+1, n_cols, lre, ONE, a_mat(1,lcs), ubound(a_mat,dim=1), &
[all …]
/dports/science/siconos/siconos-4.4.0/kernel/swig/tests/
H A Dtest_dynamical_systems.py15 a_mat = np.asarray(np.random.random((nn, nn)), dtype=np.float64) variable
20 sk.FirstOrderLinearDS: (x0, a_mat),
21 sk.FirstOrderLinearTIDS: (x0, a_mat),
82 a_mat = np.random.random((ndof, ndof))
85 ds_list.append(sk.FirstOrderLinearDS(x0, a_mat))
86 ds_list.append(sk.FirstOrderLinearDS(x0, a_mat, b_vec))
98 jac_ref += a_mat
99 rhs += np.dot(a_mat, ds.x())
120 ds_list.append(sk.FirstOrderLinearTIDS(x0, a_mat))
130 rhs = np.dot(a_mat, ds.x())
[all …]
/dports/math/elpa/elpa-2019.05.002/src/elpa1/
H A Delpa1_tridiag_template.F90333 d_vec(na) = real(a_mat(l_rows,l_cols), kind=rk)
336 d_vec(na) = a_mat(l_rows,l_cols)
374 v_row(1:l_rows) = a_mat(1:l_rows,l_cols+1)
447 a_mat(1:l_rows,l_cols+1) = v_row(1:l_rows)
826 a_mat(l_rows,l_cols) = a_mat(l_rows,l_cols) &
830 d_vec(istep-1) = a_mat(l_rows,l_cols)
833 d_vec(istep-1) = real(a_mat(l_rows,l_cols),kind=rk)
861 vrl = a_mat(1,l_cols)
874 a_mat(1,l_cols) = 1. ! for consistency only
897 d_vec(1) = PRECISION_REAL(a_mat(1,1))
[all …]
/dports/devel/ga/ga-5.8/global/examples/conjugate_gradient/
H A Dcomputeloops.F4 subroutine f_matvecmul(a_mat, argument
16 double precision a_mat(*)
28 tmprowsum=tmprowsum+a_mat(l)*mult_vec(mycollist(l)+1)
41 > a_mat,
46 double precision a_mat(*)
61 minv(k)=10.0/a_mat(l)
/dports/audio/praat/praat-6.2.03/external/gsl/
H A Dgsl_ode-initval__bsimp.c47 gsl_matrix *a_mat; /* workspace for linear system matrix */ member
209 gsl_matrix *const a_mat = state->a_mat; in bsimp_step_local() local
243 gsl_matrix_set (a_mat, i, j, -h * gsl_matrix_get (dfdy, i, j)); in bsimp_step_local()
245 gsl_matrix_set (a_mat, i, i, gsl_matrix_get (a_mat, i, i) + 1.0); in bsimp_step_local()
250 gsl_linalg_LU_decomp (a_mat, p_vec, &signum); in bsimp_step_local()
263 gsl_linalg_LU_solve (a_mat, p_vec, &y_temp_vec.vector, &delta_temp_vec.vector); in bsimp_step_local()
296 gsl_linalg_LU_solve (a_mat, p_vec, &rhs_temp_vec.vector, &delta_temp_vec.vector); in bsimp_step_local()
330 gsl_linalg_LU_solve (a_mat, p_vec, &rhs_temp_vec.vector, &delta_temp_vec.vector); in bsimp_step_local()
355 state->a_mat = gsl_matrix_alloc (dim, dim); in bsimp_alloc()
551 gsl_matrix_free (state->a_mat); in bsimp_free()
/dports/math/gsl/gsl-2.7/ode-initval2/
H A Dbsimp.c48 gsl_matrix *a_mat; /* workspace for linear system matrix */ member
209 gsl_matrix *const a_mat = state->a_mat; in bsimp_step_local() local
243 gsl_matrix_set (a_mat, i, j, -h * gsl_matrix_get (dfdy, i, j)); in bsimp_step_local()
245 gsl_matrix_set (a_mat, i, i, gsl_matrix_get (a_mat, i, i) + 1.0); in bsimp_step_local()
250 gsl_linalg_LU_decomp (a_mat, p_vec, &signum); in bsimp_step_local()
263 gsl_linalg_LU_solve (a_mat, p_vec, &y_temp_vec.vector, in bsimp_step_local()
297 gsl_linalg_LU_solve (a_mat, p_vec, &rhs_temp_vec.vector, in bsimp_step_local()
332 gsl_linalg_LU_solve (a_mat, p_vec, &rhs_temp_vec.vector, in bsimp_step_local()
358 state->a_mat = gsl_matrix_alloc (dim, dim); in bsimp_alloc()
554 gsl_matrix_free (state->a_mat); in bsimp_free()
/dports/math/gsl/gsl-2.7/ode-initval/
H A Dbsimp.c47 gsl_matrix *a_mat; /* workspace for linear system matrix */ member
209 gsl_matrix *const a_mat = state->a_mat; in bsimp_step_local() local
243 gsl_matrix_set (a_mat, i, j, -h * gsl_matrix_get (dfdy, i, j)); in bsimp_step_local()
245 gsl_matrix_set (a_mat, i, i, gsl_matrix_get (a_mat, i, i) + 1.0); in bsimp_step_local()
250 gsl_linalg_LU_decomp (a_mat, p_vec, &signum); in bsimp_step_local()
263 gsl_linalg_LU_solve (a_mat, p_vec, &y_temp_vec.vector, &delta_temp_vec.vector); in bsimp_step_local()
296 gsl_linalg_LU_solve (a_mat, p_vec, &rhs_temp_vec.vector, &delta_temp_vec.vector); in bsimp_step_local()
330 gsl_linalg_LU_solve (a_mat, p_vec, &rhs_temp_vec.vector, &delta_temp_vec.vector); in bsimp_step_local()
355 state->a_mat = gsl_matrix_alloc (dim, dim); in bsimp_alloc()
551 gsl_matrix_free (state->a_mat); in bsimp_free()
/dports/science/cp2k-data/cp2k-7.1.0/src/
H A Dgle_system_types.F51 REAL(dp), POINTER :: a_mat(:, :), c_mat(:, :) component
93 ALLOCATE (gle%a_mat(gle%ndim, gle%ndim))
112 gle%a_mat(j, k) = list(i)
124 gle%a_mat = gle%a_mat*a_scale
231 IF (ASSOCIATED(gle%a_mat)) THEN
232 DEALLOCATE (gle%a_mat)
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/
H A Dgle_system_types.F49 REAL(dp), POINTER :: a_mat(:, :), c_mat(:, :) component
91 ALLOCATE (gle%a_mat(gle%ndim, gle%ndim))
110 gle%a_mat(j, k) = list(i)
122 gle%a_mat = gle%a_mat*a_scale
227 IF (ASSOCIATED(gle%a_mat)) THEN
228 DEALLOCATE (gle%a_mat)
/dports/math/clblast/CLBlast-1.1.0/test/
H A Dwrapper_cuda.hpp108 T* a_mat = nullptr; member
121 … kBufMatA) { buffers_host.a_mat = std::vector<T>(args.a_size, static_cast<T>(0)); CUDAToHost(&buff… in CUDAToHost()
136 else if (name == kBufMatA) { HostToCUDA(&buffers.a_mat, buffers_host.a_mat, args.a_size); } in HostToCUDA()
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/motion/
H A Dpint_gle.F83 REAL(dp), DIMENSION(:, :), POINTER :: a_mat, e_tmp, h_tmp, s_tmp local
115 a_mat => gle%gle_s
119 …CALL DGEMM('N', 'N', ndim, num, ndim, alpha, a_mat(1, 1), ndim, e_tmp(1, 1), ndim, beta, h_tmp(1, …
121 a_mat => gle%gle_t
123 …CALL DGEMM("N", "N", ndim, num, ndim, alpha, a_mat(1, 1), ndim, s_tmp(1, 1), ndim, beta, h_tmp(1, …
H A Dpint_piglet.F114 NULLIFY (piglet_therm%a_mat)
115 ALLOCATE (piglet_therm%a_mat(piglet_therm%nsp1, piglet_therm%nsp1, p))
116 piglet_therm%a_mat(:, :, :) = 0.0_dp
230 (piglet_therm%a_mat(i, j, imode), j=1, piglet_therm%nsp1)
240 CALL a_mat_to_cp2k(piglet_therm%a_mat, p, &
269 CALL mp_bcast(piglet_therm%a_mat, &
298 CALL gle_matrix_exp(M=(-0.5_dp*dt)*piglet_therm%a_mat(:, :, i), & !dt scaled A matrix
545 DEALLOCATE (piglet_therm%a_mat)
573 SUBROUTINE a_mat_to_cp2k(a_mat, p, nsp1, myunit, msg) argument
575 REAL(KIND=dp), DIMENSION(:, :, :), POINTER :: a_mat local
[all …]
/dports/math/clblast/CLBlast-1.1.0/test/routines/level2/
H A Dxsyr.hpp79 buffers.a_mat(), args.a_offset, args.a_ld, in RunRoutine()
94 buffers.a_mat, args.a_offset, args.a_ld, in RunReference1()
108 buffers_host.a_mat, args.a_offset, args.a_ld); in RunReference2()
120 buffers.a_mat, args.a_offset, args.a_ld); in RunReference3()
128 buffers.a_mat.Read(queue, args.a_size, result); in DownloadResult()
H A Dxher.hpp79 buffers.a_mat(), args.a_offset, args.a_ld, in RunRoutine()
94 buffers.a_mat, args.a_offset, args.a_ld, in RunReference1()
108 buffers_host.a_mat, args.a_offset, args.a_ld); in RunReference2()
120 buffers.a_mat, args.a_offset, args.a_ld); in RunReference3()
128 buffers.a_mat.Read(queue, args.a_size, result); in DownloadResult()
H A Dxsyr2.hpp84 buffers.a_mat(), args.a_offset, args.a_ld, in RunRoutine()
100 buffers.a_mat, args.a_offset, args.a_ld, in RunReference1()
115 buffers_host.a_mat, args.a_offset, args.a_ld); in RunReference2()
128 buffers.a_mat, args.a_offset, args.a_ld); in RunReference3()
136 buffers.a_mat.Read(queue, args.a_size, result); in DownloadResult()
H A Dxher2.hpp84 buffers.a_mat(), args.a_offset, args.a_ld, in RunRoutine()
100 buffers.a_mat, args.a_offset, args.a_ld, in RunReference1()
115 buffers_host.a_mat, args.a_offset, args.a_ld); in RunReference2()
128 buffers.a_mat, args.a_offset, args.a_ld); in RunReference3()
136 buffers.a_mat.Read(queue, args.a_size, result); in DownloadResult()
H A Dxgeru.hpp86 buffers.a_mat(), args.a_offset, args.a_ld, in RunRoutine()
101 buffers.a_mat, args.a_offset, args.a_ld, in RunReference1()
115 buffers_host.a_mat, args.a_offset, args.a_ld); in RunReference2()
127 buffers.a_mat, args.a_offset, args.a_ld); in RunReference3()
135 buffers.a_mat.Read(queue, args.a_size, result); in DownloadResult()
H A Dxger.hpp86 buffers.a_mat(), args.a_offset, args.a_ld, in RunRoutine()
101 buffers.a_mat, args.a_offset, args.a_ld, in RunReference1()
115 buffers_host.a_mat, args.a_offset, args.a_ld); in RunReference2()
127 buffers.a_mat, args.a_offset, args.a_ld); in RunReference3()
135 buffers.a_mat.Read(queue, args.a_size, result); in DownloadResult()
H A Dxgerc.hpp86 buffers.a_mat(), args.a_offset, args.a_ld, in RunRoutine()
101 buffers.a_mat, args.a_offset, args.a_ld, in RunReference1()
115 buffers_host.a_mat, args.a_offset, args.a_ld); in RunReference2()
127 buffers.a_mat, args.a_offset, args.a_ld); in RunReference3()
135 buffers.a_mat.Read(queue, args.a_size, result); in DownloadResult()
/dports/science/cp2k-data/cp2k-7.1.0/src/motion/
H A Dpint_gle.F87 REAL(dp), DIMENSION(:, :), POINTER :: a_mat, e_tmp, h_tmp, s_tmp local
122 a_mat => gle%gle_s
126 …CALL DGEMM('N', 'N', ndim, num, ndim, alpha, a_mat(1, 1), ndim, e_tmp(1, 1), ndim, beta, h_tmp(1, …
128 a_mat => gle%gle_t
130 …CALL DGEMM("N", "N", ndim, num, ndim, alpha, a_mat(1, 1), ndim, s_tmp(1, 1), ndim, beta, h_tmp(1, …
H A Dpint_piglet.F116 NULLIFY (piglet_therm%a_mat)
117 ALLOCATE (piglet_therm%a_mat(piglet_therm%nsp1, piglet_therm%nsp1, p))
118 piglet_therm%a_mat(:, :, :) = 0.0_dp
232 (piglet_therm%a_mat(i, j, imode), j=1, piglet_therm%nsp1)
242 CALL a_mat_to_cp2k(piglet_therm%a_mat, p, &
271 CALL mp_bcast(piglet_therm%a_mat, &
302 CALL gle_matrix_exp(M=(-0.5_dp*dt)*piglet_therm%a_mat(:, :, i), & !dt scaled A matrix
549 DEALLOCATE (piglet_therm%a_mat)
578 SUBROUTINE a_mat_to_cp2k(a_mat, p, nsp1, myunit, msg) argument
580 REAL(KIND=dp), DIMENSION(:, :, :), POINTER :: a_mat local
[all …]
/dports/math/elpa/elpa-2019.05.002/src/helpers/
H A Dmatrix_plot.F9024 …subroutine prmat(na, useGpu, a_mat, a_dev, lda, matrixCols, nblk, my_prow, my_pcol, np_rows, np_co… argument
35 real(kind=REAL_DATATYPE), intent(in) :: a_mat(lda,matrixCols) local
55 write(out_unit, *) a_mat(row, :)
/dports/math/cgal/CGAL-5.3/demo/Polyhedron/Plugins/Mesh_3/
H A DVolume_plane_intersection.cpp152 QMatrix4x4 a_mat, c_mat; in draw() local
155 a_mat.data()[i] = (float)mat[i]; in draw()
162 getEdgeContainer(1)->setFrameMatrix(a_mat*c_mat); in draw()
175 QMatrix4x4 a_mat, b_mat; in draw() local
178 a_mat.data()[i] = (float)mat[i]; in draw()
185 getEdgeContainer(2)->setFrameMatrix(a_mat*b_mat); in draw()

1234567