TRIQS/nda 1.3.0
Multi-dimensional array library for C++
Loading...
Searching...
No Matches
basic_array_view.hpp
Go to the documentation of this file.
1// Copyright (c) 2019--present, The Simons Foundation
2// This file is part of TRIQS/nda and is licensed under the Apache License, Version 2.0.
3// SPDX-License-Identifier: Apache-2.0
4// See LICENSE in the root of this distribution for details.
5
10
11#pragma once
12
13#include "./basic_functions.hpp"
14#include "./clef.hpp"
15#include "./concepts.hpp"
16#include "./declarations.hpp"
17#include "./exceptions.hpp"
18#include "./iterators.hpp"
19#include "./layout/for_each.hpp"
20#include "./layout/idx_map.hpp"
22#include "./layout/range.hpp"
23#include "./macros.hpp"
25#include "./mem/memcpy.hpp"
26#include "./mem/policies.hpp"
27#include "./traits.hpp"
28
29#include <itertools/itertools.hpp>
30
31#include <algorithm>
32#include <array>
33#include <cstring>
34#include <memory>
35#include <ranges>
36#include <type_traits>
37#include <utility>
38
39#ifdef NDA_ENFORCE_BOUNDCHECK
40#include <exception>
41#include <iostream>
42#endif // NDA_ENFORCE_BOUNDCHECK
43
44namespace std {
45
51 template <typename V1, int R1, typename LP1, char A1, typename AP1, typename OP1, typename V2, int R2, typename LP2, char A2, typename AP2,
52 typename OP2>
54
55} // namespace std
56
57namespace nda {
58
115 template <typename ValueType, int Rank, typename LayoutPolicy, char Algebra, typename AccessorPolicy, typename OwningPolicy>
116 class basic_array_view {
117 // Compile-time checks.
118 static_assert((Algebra != 'N'), "Internal error in nda::basic_array_view: Algebra 'N' not supported");
119 static_assert((Algebra != 'M') or (Rank == 2), "Internal error in nda::basic_array_view: Algebra 'M' requires a rank 2 view");
120 static_assert((Algebra != 'V') or (Rank == 1), "Internal error in nda::basic_array_view: Algebra 'V' requires a rank 1 view");
121
122 public:
124 using value_type = ValueType;
125
127 using layout_policy_t = LayoutPolicy;
128
130 using layout_t = typename LayoutPolicy::template mapping<Rank>;
131
133 using accessor_policy_t = AccessorPolicy;
134
136 using owning_policy_t = OwningPolicy;
137
139 using storage_t = typename OwningPolicy::template handle<ValueType>;
140
142 using regular_type = basic_array<std::remove_const_t<ValueType>, Rank, C_layout, Algebra, heap<mem::get_addr_space<storage_t>>>;
143
145 static constexpr int rank = Rank;
146
147 private:
148 // Type of the view itself.
149 using self_t = basic_array_view;
150
151 // Constexpr variable that is true if the view is a view (always for basic_array_view).
152 static constexpr bool is_view = true;
153
154 // Constexpr variable that is true if the value_type is const.
155 static constexpr bool is_const = std::is_const_v<ValueType>;
156
157 // Memory layout of the view, i.e. the nda::idx_map.
158 layout_t lay;
159
160 // Memory handle of the view.
161 storage_t sto;
162
163 // Declare any nda::basic_array as a friend.
164 template <typename T, int R, typename L, char A, typename CP>
165 friend class basic_array;
166
167 // Declare any other nda::basic_array_view as a friend.
168 template <typename T, int R, typename L, char A, typename AP, typename OP>
169 friend class basic_array_view;
170
171 // Check the layout compatibility of this view with another layout.
172 template <typename L>
173 static constexpr bool requires_runtime_check = not layout_property_compatible(L::template mapping<Rank>::layout_prop, layout_t::layout_prop);
174
175 public:
176 // FIXME : TRIQS PORTING
177 // private constructor for the previous friend
186 basic_array_view(layout_t const &idxm, storage_t st) : lay(idxm), sto(std::move(st)) {}
187
188 public:
189 // backward : FIXME : temporary to be removed
191 [[deprecated]] auto as_array_view() { return basic_array_view<ValueType, Rank, LayoutPolicy, 'A', AccessorPolicy, OwningPolicy>{*this}; };
192
194 [[deprecated]] auto as_array_view() const {
195 return basic_array_view<const ValueType, Rank, LayoutPolicy, 'A', AccessorPolicy, OwningPolicy>{*this};
196 };
197
199 basic_array_view() = default;
200
202 basic_array_view(basic_array_view &&) = default;
203
205 basic_array_view(basic_array_view const &) = default;
206
216 template <MemoryArrayOfRank<Rank> A>
217 requires((get_layout_info<A>.stride_order == layout_t::stride_order_encoded)
218 and (std::is_same_v<std::remove_const_t<ValueType>, get_value_t<A>>)
219 and (std::is_const_v<ValueType> or !std::is_const_v<typename std::decay_t<A>::value_type>))
220 explicit(requires_runtime_check<typename std::decay_t<A>::layout_policy_t>)
221 basic_array_view(A &&a) noexcept // NOLINT (should we forward the reference?)
222 : lay(a.indexmap()), sto(a.storage()) {}
223
233 basic_array_view(std::array<long, Rank> const &shape, ValueType *p) noexcept : basic_array_view(layout_t{shape}, p) {}
234
244 basic_array_view(layout_t const &idxm, ValueType *p) noexcept : lay(idxm), sto{p} {}
245
252 template <size_t N>
253 requires(Rank == 1)
254 explicit basic_array_view(std::array<ValueType, N> &a) noexcept : basic_array_view{{long(N)}, a.data()} {}
255
262 template <size_t N>
263 requires(Rank == 1 and std::is_const_v<ValueType>)
264 explicit basic_array_view(std::array<std::remove_const_t<ValueType>, N> const &a) noexcept : basic_array_view{{long(N)}, a.data()} {}
265
272 template <std::ranges::contiguous_range R>
273 requires(Rank == 1 and not MemoryArray<R>
274 and (std::is_same_v<std::ranges::range_value_t<R>, ValueType> or std::is_same_v<const std::ranges::range_value_t<R>, ValueType>))
275 explicit basic_array_view(R &rg) noexcept : basic_array_view{{long(std::ranges::size(rg))}, std::to_address(std::begin(rg))} {}
276
285 basic_array_view &operator=(basic_array_view const &rhs) noexcept {
286 assign_from_ndarray(rhs);
287 return *this;
288 }
289
299 template <ArrayOfRank<Rank> RHS>
300 basic_array_view &operator=(RHS const &rhs) noexcept {
301 static_assert(!is_const, "Cannot assign to an nda::basic_array_view with const value_type");
302 assign_from_ndarray(rhs);
303 return *this;
304 }
305
316 template <typename RHS>
317 basic_array_view &operator=(RHS const &rhs) noexcept
319 {
320 static_assert(!is_const, "Cannot assign to an nda::basic_array_view with const value_type");
321 assign_from_scalar(rhs);
322 return *this;
323 }
324
333 template <ArrayInitializer<basic_array_view> Initializer>
334 basic_array_view &operator=(Initializer const &initializer) noexcept {
335 EXPECTS(shape() == initializer.shape());
336 initializer.invoke(*this);
337 return *this;
338 }
339
354 template <typename T, int R, typename LP, char A, typename AP, typename OP>
355 void rebind(basic_array_view<T, R, LP, A, AP, OP> v) noexcept {
356 static_assert(R == Rank, "Cannot rebind a view to another view of a different rank");
357 static_assert(std::is_same_v<std::remove_const_t<T>, std::remove_const_t<ValueType>>,
358 "Cannot rebind a view to another view with a different value_type (except for const)");
359 static constexpr bool same_type = std::is_same_v<T, ValueType>;
360 static_assert(same_type or is_const, "Cannot rebind a view with non-const value_type to another view with const value_type");
361 if constexpr (same_type) {
362 // FIXME Error message in layout error !
363 lay = v.lay;
364 sto = v.sto;
365 } else if constexpr (is_const) {
366 // the last if is always trivially true but in case of an error in the static_assert above,
367 // it improves the error message by not compiling the = afterwards
368 lay = layout_t{v.indexmap()};
369 sto = storage_t{v.storage()};
370 }
371 }
372
381 friend void swap(basic_array_view &a, basic_array_view &b) noexcept {
382 std::swap(a.lay, b.lay);
383 std::swap(a.sto, b.sto);
384 }
385
394 friend void deep_swap(basic_array_view a, basic_array_view b) noexcept {
395 auto tmp = make_regular(a);
396 a = b;
397 b = tmp;
398 }
399
400// include common functionality of arrays and views
401// Copyright (c) 2019--present, The Simons Foundation
402// This file is part of TRIQS/nda and is licensed under the Apache License, Version 2.0.
403// SPDX-License-Identifier: Apache-2.0
404// See LICENSE in the root of this distribution for details.
405
410[[nodiscard]] constexpr auto const &indexmap() const noexcept { return lay; }
411
416[[nodiscard]] storage_t const &storage() const & noexcept { return sto; }
417
422[[nodiscard]] storage_t &storage() & noexcept { return sto; }
423
428[[nodiscard]] storage_t storage() && noexcept { return std::move(sto); }
429
436[[nodiscard]] constexpr auto stride_order() const noexcept { return lay.stride_order; }
437
442[[nodiscard]] ValueType const *data() const noexcept { return sto.data(); }
443
448[[nodiscard]] ValueType *data() noexcept { return sto.data(); }
449
454[[nodiscard]] auto const &shape() const noexcept { return lay.lengths(); }
455
460[[nodiscard]] auto const &strides() const noexcept { return lay.strides(); }
461
466[[nodiscard]] long size() const noexcept { return lay.size(); }
467
472[[nodiscard]] long is_contiguous() const noexcept { return lay.is_contiguous(); }
473
478[[nodiscard]] long has_positive_strides() const noexcept { return lay.has_positive_strides(); }
479
484[[nodiscard]] bool empty() const { return sto.is_null(); }
485
487[[nodiscard]] bool is_empty() const noexcept { return sto.is_null(); }
488
493[[nodiscard]] long extent(int i) const noexcept {
494#ifdef NDA_ENFORCE_BOUNDCHECK
495 if (i < 0 || i >= rank) {
496 std::cerr << "Error in extent: Dimension " << i << " is incompatible with array of rank " << rank << std::endl;
497 std::terminate();
498 }
499#endif
500 return lay.lengths()[i];
501}
502
504[[nodiscard]] long shape(int i) const noexcept { return extent(i); }
505
510[[nodiscard]] auto indices() const noexcept { return itertools::product_range(shape()); }
511
516static constexpr bool is_stride_order_C() noexcept { return layout_t::is_stride_order_C(); }
517
522static constexpr bool is_stride_order_Fortran() noexcept { return layout_t::is_stride_order_Fortran(); }
523
533decltype(auto) operator()(_linear_index_t idx) const noexcept {
534 if constexpr (layout_t::layout_prop == layout_prop_e::strided_1d)
535 return sto[idx.value * lay.min_stride()];
536 else if constexpr (layout_t::layout_prop == layout_prop_e::contiguous)
537 return sto[idx.value];
538 else
539 static_assert(always_false<layout_t>, "Internal error in array/view: Calling this type with a _linear_index_t is not allowed");
540}
541
543decltype(auto) operator()(_linear_index_t idx) noexcept {
544 if constexpr (layout_t::layout_prop == layout_prop_e::strided_1d)
545 return sto[idx.value * lay.min_stride()];
546 else if constexpr (layout_t::layout_prop == layout_prop_e::contiguous)
547 return sto[idx.value];
548 else
549 static_assert(always_false<layout_t>, "Internal error in array/view: Calling this type with a _linear_index_t is not allowed");
550}
551
552private:
553// Constexpr variable that is true if bounds checking is disabled.
554#ifdef NDA_ENFORCE_BOUNDCHECK
555static constexpr bool has_no_boundcheck = false;
556#else
557static constexpr bool has_no_boundcheck = true;
558#endif
559
560public:
577template <char ResultAlgebra, bool SelfIsRvalue, typename Self, typename... Ts>
578FORCEINLINE static decltype(auto) call(Self &&self, Ts const &...idxs) noexcept(has_no_boundcheck) {
579 // resulting value type
580 using r_v_t = std::conditional_t<std::is_const_v<std::remove_reference_t<Self>>, ValueType const, ValueType>;
581
582 // behavior depends on the given arguments
583 if constexpr (clef::is_any_lazy<Ts...>) {
584 // if there are lazy arguments, e.g. as in A(i_) << i_, a lazy expression is returned
585 return clef::make_expr_call(std::forward<Self>(self), idxs...);
586 } else if constexpr (sizeof...(Ts) == 0) {
587 // if no arguments are given, a full view is returned
588 return basic_array_view<r_v_t, Rank, LayoutPolicy, Algebra, AccessorPolicy, OwningPolicy>{self.lay, self.sto};
589 } else {
590 // otherwise we check the arguments and either access a single element or make a slice
591 static_assert(((layout_t::template argument_is_allowed_for_call_or_slice<Ts> + ...) > 0),
592 "Error in array/view: Slice arguments must be convertible to range, ellipsis, or long (or string if the layout permits it)");
593
594 // number of arguments convertible to long
595 static constexpr int n_args_long = (layout_t::template argument_is_allowed_for_call<Ts> + ...);
596
597 if constexpr (n_args_long == rank) {
598 // access a single element
599 long offset = self.lay(idxs...);
600 if constexpr (is_view or not SelfIsRvalue) {
601 // if the calling object is a view or an lvalue, we return a reference
602 return AccessorPolicy::template accessor<r_v_t>::access(self.sto.data(), offset);
603 } else {
604 // otherwise, we return a copy of the value
605 return ValueType{self.sto[offset]};
606 }
607 } else {
608 // access a slice of the view/array
609 auto const [offset, idxm] = self.lay.slice(idxs...);
610 static constexpr auto res_rank = decltype(idxm)::rank();
611 // resulting algebra
612 static constexpr char newAlgebra = (ResultAlgebra == 'M' and (res_rank == 1) ? 'V' : ResultAlgebra);
613 // resulting layout policy
614 using r_layout_p = typename detail::layout_to_policy<std::decay_t<decltype(idxm)>>::type;
615 return basic_array_view<r_v_t, res_rank, r_layout_p, newAlgebra, AccessorPolicy, OwningPolicy>{std::move(idxm), {self.sto, offset}};
616 }
617 }
618}
619
620public:
642template <typename... Ts>
643FORCEINLINE decltype(auto) operator()(Ts const &...idxs) const & noexcept(has_no_boundcheck) {
644 static_assert((rank == -1) or (sizeof...(Ts) == rank) or (sizeof...(Ts) == 0) or (ellipsis_is_present<Ts...> and (sizeof...(Ts) <= rank + 1)),
645 "Error in array/view: Incorrect number of parameters in call operator");
646 return call<Algebra, false>(*this, idxs...);
647}
648
650template <typename... Ts>
651FORCEINLINE decltype(auto) operator()(Ts const &...idxs) & noexcept(has_no_boundcheck) {
652 static_assert((rank == -1) or (sizeof...(Ts) == rank) or (sizeof...(Ts) == 0) or (ellipsis_is_present<Ts...> and (sizeof...(Ts) <= rank + 1)),
653 "Error in array/view: Incorrect number of parameters in call operator");
654 return call<Algebra, false>(*this, idxs...);
655}
656
658template <typename... Ts>
659FORCEINLINE decltype(auto) operator()(Ts const &...idxs) && noexcept(has_no_boundcheck) {
660 static_assert((rank == -1) or (sizeof...(Ts) == rank) or (sizeof...(Ts) == 0) or (ellipsis_is_present<Ts...> and (sizeof...(Ts) <= rank + 1)),
661 "Error in array/view: Incorrect number of parameters in call operator");
662 return call<Algebra, true>(*this, idxs...);
663}
664
682template <typename T>
683decltype(auto) operator[](T const &idx) const & noexcept(has_no_boundcheck) {
684 static_assert((rank == 1), "Error in array/view: Subscript operator is only available for rank 1 views/arrays in C++17/20");
685 return call<Algebra, false>(*this, idx);
686}
687
689template <typename T>
690decltype(auto) operator[](T const &x) & noexcept(has_no_boundcheck) {
691 static_assert((rank == 1), "Error in array/view: Subscript operator is only available for rank 1 views/arrays in C++17/20");
692 return call<Algebra, false>(*this, x);
693}
694
696template <typename T>
697decltype(auto) operator[](T const &x) && noexcept(has_no_boundcheck) {
698 static_assert((rank == 1), "Error in array/view: Subscript operator is only available for rank 1 views/arrays in C++17/20");
699 return call<Algebra, true>(*this, x);
700}
701
703static constexpr int iterator_rank = (has_strided_1d(layout_t::layout_prop) ? 1 : Rank);
704
707
710
711private:
712// Make an iterator for the view/array depending on its type.
713template <typename Iterator>
714[[nodiscard]] auto make_iterator(bool at_end) const noexcept {
715 if constexpr (iterator_rank == Rank) {
716 // multi-dimensional iterator
717 if constexpr (layout_t::is_stride_order_C()) {
718 // C-order case (array_iterator already traverses the data in C-order)
719 return Iterator{indexmap().lengths(), indexmap().strides(), sto.data(), at_end};
720 } else {
721 // general case (we need to permute the shape and the strides according to the stride order of the layout)
722 return Iterator{nda::permutations::apply(layout_t::stride_order, indexmap().lengths()),
723 nda::permutations::apply(layout_t::stride_order, indexmap().strides()), sto.data(), at_end};
724 }
725 } else {
726 // 1-dimensional iterator
727 return Iterator{std::array<long, 1>{size()}, std::array<long, 1>{indexmap().min_stride()}, sto.data(), at_end};
728 }
729}
730
731public:
733[[nodiscard]] const_iterator begin() const noexcept { return make_iterator<const_iterator>(false); }
734
736[[nodiscard]] const_iterator cbegin() const noexcept { return make_iterator<const_iterator>(false); }
737
739iterator begin() noexcept { return make_iterator<iterator>(false); }
740
742[[nodiscard]] const_iterator end() const noexcept { return make_iterator<const_iterator>(true); }
743
745[[nodiscard]] const_iterator cend() const noexcept { return make_iterator<const_iterator>(true); }
746
748iterator end() noexcept { return make_iterator<iterator>(true); }
749
762template <typename RHS>
763auto &operator+=(RHS const &rhs) noexcept {
764 static_assert(not is_const, "Error in array/view: Can not assign to a const view");
765 return operator=(*this + rhs);
766}
767
780template <typename RHS>
781auto &operator-=(RHS const &rhs) noexcept {
782 static_assert(not is_const, "Error in array/view: Can not assign to a const view");
783 return operator=(*this - rhs);
784}
785
798template <typename RHS>
799auto &operator*=(RHS const &rhs) noexcept {
800 static_assert(not is_const, "Error in array/view: Can not assign to a const view");
801 return operator=((*this) * rhs);
802}
803
816template <typename RHS>
817auto &operator/=(RHS const &rhs) noexcept {
818 static_assert(not is_const, "Error in array/view: Can not assign to a const view");
819 return operator=(*this / rhs);
820}
821
830template <std::ranges::contiguous_range R>
831auto &operator=(R const &rhs) noexcept
832 requires(Rank == 1 and not MemoryArray<R> and not is_scalar_for_v<R, self_t>)
833{
835 return *this;
836}
837
838private:
839// Implementation of the assignment from an n-dimensional array type.
840template <typename RHS>
841void assign_from_ndarray(RHS const &rhs) { // FIXME noexcept {
842#ifdef NDA_ENFORCE_BOUNDCHECK
843 if (this->shape() != rhs.shape())
844 NDA_RUNTIME_ERROR << "Error in assign_from_ndarray: Size mismatch:"
845 << "\n LHS.shape() = " << this->shape() << "\n RHS.shape() = " << rhs.shape();
846#endif
847 // compile-time check if assignment is possible
848 static_assert(std::is_assignable_v<value_type &, get_value_t<RHS>>, "Error in assign_from_ndarray: Incompatible value types");
849
850 // are both operands nda::MemoryArray types?
851 static constexpr bool both_in_memory = MemoryArray<self_t> and MemoryArray<RHS>;
852
853 // do both operands have the same stride order?
854 static constexpr bool same_stride_order = get_layout_info<self_t>.stride_order == get_layout_info<RHS>.stride_order;
855
856 // prefer optimized options if possible
857 if constexpr (both_in_memory and same_stride_order) {
858 if (rhs.empty()) return;
859 // are both operands strided in 1d?
860 static constexpr bool both_1d_strided = has_layout_strided_1d<self_t> and has_layout_strided_1d<RHS>;
861 if constexpr (mem::on_host<self_t, RHS> and both_1d_strided) {
862 // vectorizable copy on host
863 for (long i = 0; i < size(); ++i) (*this)(_linear_index_t{i}) = rhs(_linear_index_t{i});
864 return;
866 // check for block-layout and use mem::memcpy2D if possible
867 auto bl_layout_dst = get_block_layout(*this);
868 auto bl_layout_src = get_block_layout(rhs);
869 if (bl_layout_dst && bl_layout_src) {
870 auto [n_bl_dst, bl_size_dst, bl_str_dst] = *bl_layout_dst;
871 auto [n_bl_src, bl_size_src, bl_str_src] = *bl_layout_src;
872 // check that the total memory size is the same
873 if (n_bl_dst * bl_size_dst != n_bl_src * bl_size_src) NDA_RUNTIME_ERROR << "Error in assign_from_ndarray: Incompatible block sizes";
874 // if either destination or source consists of a single block, we can chunk it up to make the layouts compatible
875 if (n_bl_dst == 1 && n_bl_src > 1) {
876 n_bl_dst = n_bl_src;
877 bl_size_dst /= n_bl_src;
878 bl_str_dst = bl_size_dst;
879 }
880 if (n_bl_src == 1 && n_bl_dst > 1) {
881 n_bl_src = n_bl_dst;
882 bl_size_src /= n_bl_dst;
883 bl_str_src = bl_size_src;
884 }
885 // copy only if block-layouts are compatible, otherwise continue to fallback
886 if (n_bl_dst == n_bl_src && bl_size_dst == bl_size_src) {
887 mem::memcpy2D<mem::get_addr_space<self_t>, mem::get_addr_space<RHS>>((void *)data(), bl_str_dst * sizeof(value_type), (void *)rhs.data(),
888 bl_str_src * sizeof(value_type), bl_size_src * sizeof(value_type),
889 n_bl_src);
890 return;
891 }
892 }
893 }
894 }
895 // otherwise fallback to elementwise assignment
897 NDA_RUNTIME_ERROR << "Error in assign_from_ndarray: Fallback to elementwise assignment not implemented for arrays/views on the GPU";
898 }
899 nda::for_each(shape(), [this, &rhs](auto const &...args) { (*this)(args...) = rhs(args...); });
900}
901
902// Implementation to fill a view/array with a constant scalar value.
903template <typename Scalar>
904void fill_with_scalar(Scalar const &scalar) noexcept {
905 // we make a special implementation if the array is strided in 1d or contiguous
906 if constexpr (has_layout_strided_1d<self_t>) {
907 const long L = size();
908 auto *__restrict const p = data(); // no alias possible here!
909 if constexpr (has_contiguous_layout<self_t>) {
910 for (long i = 0; i < L; ++i) p[i] = scalar;
911 } else {
912 const long stri = indexmap().min_stride();
913 const long Lstri = L * stri;
914 for (long i = 0; i != Lstri; i += stri) p[i] = scalar;
915 }
916 } else {
917 // no compile-time memory layout guarantees
918 for (auto &x : *this) x = scalar;
919 }
920}
921
922// Implementation of the assignment from a scalar value.
923template <typename Scalar>
924void assign_from_scalar(Scalar const &scalar) noexcept {
925 static_assert(!is_const, "Error in assign_from_ndarray: Cannot assign to a const view");
926 if constexpr (Algebra != 'M') {
927 // element-wise assignment for non-matrix algebras
928 fill_with_scalar(scalar);
929 } else {
930 // a scalar has to be interpreted as a unit matrix for matrix algebras (the scalar in the shortest diagonal)
931 // FIXME : A priori faster to put 0 everywhere and then change the diag to avoid the if.
932 // FIXME : Benchmark and confirm.
934 fill_with_scalar(0);
935 else
936 fill_with_scalar(Scalar{0 * scalar}); // FIXME : improve this
937 const long imax = std::min(extent(0), extent(1));
938 for (long i = 0; i < imax; ++i) operator()(i, i) = scalar;
939 }
940}
941 };
942
943 // Class template argument deduction guides.
944 template <MemoryArray A>
945 basic_array_view(A &&a)
946 -> basic_array_view<std::conditional_t<std::is_const_v<std::remove_reference_t<A>>, const typename std::decay_t<A>::value_type,
947 typename std::decay_t<A>::value_type>,
948 get_rank<A>, typename std::decay_t<A>::layout_policy_t, get_algebra<A>, default_accessor, borrowed<mem::get_addr_space<A>>>;
949
950 template <typename V, size_t R>
951 basic_array_view(std::array<V, R> &a)
952 -> basic_array_view<V, 1, nda::basic_layout<nda::static_extents(R), nda::C_stride_order<1>, nda::layout_prop_e::contiguous>, 'V',
954
955 template <typename V, size_t R>
956 basic_array_view(std::array<V, R> const &a)
957 -> basic_array_view<const V, 1, nda::basic_layout<nda::static_extents(R), nda::C_stride_order<1>, nda::layout_prop_e::contiguous>, 'V',
959
960 template <std::ranges::contiguous_range R>
961 basic_array_view(R &r) -> basic_array_view<std::conditional_t<std::is_const_v<R>, const typename R::value_type, typename R::value_type>, 1,
963
964} // namespace nda
Provides definitions and type traits involving the different memory address spaces supported by nda.
void swap(nda::basic_array_view< V1, R1, LP1, A1, AP1, OP1 > &a, nda::basic_array_view< V2, R2, LP2, A2, AP2, OP2 > &b)=delete
std::swap is deleted for nda::basic_array_view.
Provides basic functions to create and manipulate arrays and views.
Iterator for nda::basic_array and nda::basic_array_view types.
A generic view of a multi-dimensional array.
auto & operator=(R const &rhs) noexcept
Assignment operator makes a deep copy of a general contiguous range and assigns it to the 1-dimension...
const_iterator end() const noexcept
Get a const iterator to the end of the view/array.
ValueType const * data() const noexcept
Get a pointer to the actual data (in general this is not the beginning of the memory block for a view...
static constexpr bool is_stride_order_C() noexcept
Is the stride order of the view/array in C-order?
iterator begin() noexcept
Get an iterator to the beginning of the view/array.
ValueType * data() noexcept
Get a pointer to the actual data (in general this is not the beginning of thr memory block for a view...
basic_array_view & operator=(RHS const &rhs) noexcept
Assignment operator makes a deep copy of the contents of an nda::ArrayOfRank object.
long has_positive_strides() const noexcept
Are all the strides of the memory layout of the view/array positive?
typename OwningPolicy::template handle< ValueType > storage_t
Type of the memory handle (see Handles).
auto & operator/=(RHS const &rhs) noexcept
Division assignment operator.
static __inline__ decltype(auto) call(Self &&self, Ts const &...idxs) noexcept(has_no_boundcheck)
Implementation of the function call operator.
basic_array_view(layout_t const &idxm, ValueType *p) noexcept
Construct a view from a bare pointer to some contiguous data and a memory layout.
basic_array_view(R &rg) noexcept
Construct a 1-dimensional view of a general contiguous range.
basic_array_view & operator=(basic_array_view const &rhs) noexcept
Copy assignment operator makes a deep copy of the contents of the view.
basic_array_view(std::array< ValueType, N > &a) noexcept
Construct a 1-dimensional view of a std::array.
basic_array_view & operator=(Initializer const &initializer) noexcept
Assignment operator uses an nda::ArrayInitializer to assign to the view.
auto const & strides() const noexcept
Get the strides of the view/array (see nda::idx_map for more details on how we define strides).
long shape(int i) const noexcept
storage_t storage() &&noexcept
Get the data storage of the view/array.
typename LayoutPolicy::template mapping< Rank > layout_t
Type of the memory layout (an nda::idx_map).
basic_array< std::remove_const_t< ValueType >, Rank, C_layout, Algebra, heap< mem::get_addr_space< storage_t > > > regular_type
The associated regular (nda::basic_array) type.
array_iterator< iterator_rank, ValueType, typename AccessorPolicy::template accessor< ValueType >::pointer > iterator
Iterator type of the view/array.
auto & operator+=(RHS const &rhs) noexcept
Addition assignment operator.
auto indices() const noexcept
Get a range that generates all valid index tuples.
basic_array_view()=default
Default constructor constructs an empty view with a default constructed memory handle and layout.
long is_contiguous() const noexcept
Is the memory layout of the view/array contiguous?
storage_t & storage() &noexcept
Get the data storage of the view/array.
static constexpr bool is_stride_order_Fortran() noexcept
Is the stride order of the view/array in Fortran-order?
auto & operator*=(RHS const &rhs) noexcept
Multiplication assignment operator.
basic_array_view(std::array< std::remove_const_t< ValueType >, N > const &a) noexcept
Construct a 1-dimensional view of a std::array.
friend void deep_swap(basic_array_view a, basic_array_view b) noexcept
Swap two views by swapping their data.
iterator end() noexcept
Get an iterator to the end of the view/array.
ValueType value_type
Type of the values in the view (might be const).
long size() const noexcept
Get the total size of the view/array.
auto & operator-=(RHS const &rhs) noexcept
Subtraction assignment operator.
bool empty() const
Is the view/array empty?
basic_array_view & operator=(RHS const &rhs) noexcept
Assignment operator assigns a scalar to the view.
basic_array_view(std::array< long, Rank > const &shape, ValueType *p) noexcept
Construct a view from a bare pointer to some contiguous data and a shape.
OwningPolicy owning_policy_t
Type of the owning policy (see Memory policies).
LayoutPolicy layout_policy_t
Type of the memory layout policy (see Layout policies).
array_iterator< iterator_rank, ValueType const, typename AccessorPolicy::template accessor< ValueType >::pointer > const_iterator
Const iterator type of the view/array.
bool is_empty() const noexcept
friend void swap(basic_array_view &a, basic_array_view &b) noexcept
Swap two views by swapping their memory handles and layouts.
constexpr auto stride_order() const noexcept
Get the stride order of the memory layout of the view/array (see nda::idx_map for more details on how...
const_iterator cbegin() const noexcept
Get a const iterator to the beginning of the view/array.
basic_array_view(layout_t const &idxm, storage_t st)
Construct a view from a given layout and memory handle.
AccessorPolicy accessor_policy_t
Type of the accessor policy (see e.g. nda::default_accessor).
basic_array_view(basic_array_view &&)=default
Default move constructor moves the memory handle and layout.
void rebind(basic_array_view< T, R, LP, A, AP, OP > v) noexcept
Rebind the current view to another view.
basic_array_view(basic_array_view const &)=default
Default copy constructor copies the memory handle and layout.
long extent(int i) const noexcept
Get the extent of the ith dimension.
const_iterator begin() const noexcept
Get a const iterator to the beginning of the view/array.
const_iterator cend() const noexcept
Get a const iterator to the end of the view/array.
Includes all clef relevant headers.
Check if a given type satisfies the memory array concept.
Definition concepts.hpp:248
Provides concepts for the nda library.
Provides various convenient aliases and helper functions for nda::basic_array and nda::basic_array_vi...
Provides a custom runtime error class and macros to assert conditions and throw exceptions.
Provides for_each functions for multi-dimensional arrays/views.
decltype(auto) make_regular(A &&a)
Make a given object regular.
basic_array_view< ValueType const, Rank, Layout, 'A', default_accessor, borrowed<> > array_const_view
Same as nda::array_view except for const value types.
constexpr char get_algebra
Constexpr variable that specifies the algebra of a type.
Definition traits.hpp:115
constexpr uint64_t static_extents(int i0, Is... is)
Encode the given shape into a single integer using the nda::encode function.
constexpr bool have_same_value_type_v
Constexpr variable that is true if all types in As have the same value type as A0.
Definition traits.hpp:185
constexpr int get_rank
Constexpr variable that specifies the rank of an nda::Array or of a contiguous 1-dimensional range.
Definition traits.hpp:125
std::decay_t< decltype(get_first_element(std::declval< A const >()))> get_value_t
Get the value type of an array/view or a scalar type.
Definition traits.hpp:181
auto make_expr_call(F &&f, Args &&...args)
Create a function call expression from a callable object and a list of arguments.
Definition make_lazy.hpp:63
constexpr bool is_any_lazy
Constexpr variable that is true if any of the given types is lazy.
Definition utils.hpp:145
constexpr uint64_t C_stride_order
C/Row-major stride order.
Definition idx_map.hpp:52
constexpr bool layout_property_compatible(layout_prop_e from, layout_prop_e to)
Checks if two layout properties are compatible with each other.
Definition traits.hpp:226
constexpr bool ellipsis_is_present
Constexpr variable that is true if the parameter pack Args contains an nda::ellipsis.
Definition range.hpp:56
constexpr bool has_strided_1d(layout_prop_e lp)
Checks if a layout property has the strided_1d property.
Definition traits.hpp:255
__inline__ void for_each(std::array< Int, R > const &shape, F &&f)
Loop over all possible index values of a given shape and apply a function to them.
Definition for_each.hpp:116
constexpr bool has_layout_strided_1d
Constexpr variable that is true if type A has the strided_1d nda::layout_prop_e guarantee.
Definition traits.hpp:323
auto get_block_layout(A const &a)
Check if a given nda::MemoryArray has a block-strided layout.
constexpr layout_info_t get_layout_info
Constexpr variable that specifies the nda::layout_info_t of type A.
Definition traits.hpp:310
constexpr bool has_contiguous_layout
Constexpr variable that is true if type A has the contiguous nda::layout_prop_e guarantee.
Definition traits.hpp:319
static constexpr bool on_device
Constexpr variable that is true if all given types have a Device address space.
static constexpr AddressSpace get_addr_space
Variable template providing the address space for different types.
static constexpr bool on_host
Constexpr variable that is true if all given types have a Host address space.
heap_basic< mem::mallocator< AdrSp > > heap
Alias template of the nda::heap_basic policy using an nda::mem::mallocator.
Definition policies.hpp:52
void memcpy2D(void *dest, size_t dpitch, const void *src, size_t spitch, size_t width, size_t height)
Call CUDA's cudaMemcpy2D function or simulate its behavior on the Host based on the given address spa...
Definition memcpy.hpp:73
constexpr std::array< T, N > apply(std::array< Int, N > const &p, std::array< T, N > const &a)
Apply a permutation to a std::array.
static constexpr bool always_false
Constexpr variable that is always false regardless of the types in Ts (used to trigger static_assert)...
Definition traits.hpp:60
constexpr bool is_scalar_for_v
Constexpr variable used to check requirements when initializing an nda::basic_array or nda::basic_arr...
Definition traits.hpp:82
constexpr bool is_scalar_or_convertible_v
Constexpr variable that is true if type S is a scalar type (see nda::is_scalar_v) or if a std::comple...
Definition traits.hpp:75
Provides a class that maps multi-dimensional indices to a linear index and vice versa.
Provides an iterator for nda::basic_array and nda::basic_array_view types.
Macros used in the nda library.
Defines various memory handling policies.
Provides a generic memcpy and memcpy2D function for different address spaces.
Provides utilities to work with permutations and to compactly encode/decode std::array objects.
Includes the itertools header and provides some additional utilities.
A small wrapper around a single long integer to be used as a linear index.
Definition traits.hpp:332
Contiguous layout policy with C-order (row-major order).
Definition policies.hpp:36
Memory policy using an nda::mem::handle_borrowed.
Definition policies.hpp:97
Default accessor for various array and view types.
Definition accessors.hpp:25
Provides type traits for the nda library.