This documentation is automatically generated by online-judge-tools/verification-helper
View the Project on GitHub rainbou-kpr/library
#define PROBLEM "https://judge.u-aizu.ac.jp/onlinejudge/description.jsp?id=3314" #define ERROR 1e-6 #include "../cpp/matrix.hpp" #include "../cpp/vector.hpp" #include <iomanip> #include <iostream> int main() { // https://qiita.com/KowerKoint/items/e697f896c749f756235f double phi = (1 + std::sqrt(5)) / 2; std::vector<Vector<double, 3>> base = { {0., 1., phi}, {phi, 0., 1.}, {1., phi, 0.}, {-1., phi, 0.}, {-phi, 0., 1.}, {0., -1., phi}, {phi, 0., -1.}, {0., 1., -phi}, {-phi, 0., -1.}, {-1., -phi, 0.}, {1., -phi, 0.}, {0., -1., -phi} }; Vector<double, 3> base_g = (base[0] + base[1] + base[2]) / 3; double k = base_g.abs() * (base[1]-base[0]).abs() / (cross(base[1]-base[0], base[2]-base[0])).abs(); Matrix<double> base_abc(3, 3); for(int i = 0; i < 3; i++) base_abc[i].assign(base[i].v.begin(), base[i].v.end()); Vector<double, 3> a, b, c; std::cin >> a >> b >> c; auto g = (a + b + c) / 3; auto t = cross((b - a), (c - a)) * (-k / (b - a).abs()) + g; Matrix<double> trans_abc(3, 3); for(int j = 0; j < 3; j++) trans_abc[0][j] = a[j] - t[j]; for(int j = 0; j < 3; j++) trans_abc[1][j] = b[j] - t[j]; for(int j = 0; j < 3; j++) trans_abc[2][j] = c[j] - t[j]; auto s = base_abc.inv() * trans_abc; std::cout << std::fixed << std::setprecision(10); int n; std::cin >> n; while(n--) { int v; std::cin >> v; v--; auto p = std::vector<double>(base[3+v].v.begin(), base[3+v].v.end()) * s; std::cout << Vector<double, 3>{p[0], p[1], p[2]} + t << std::endl; } }
#line 1 "test/aoj-3314.test.cpp" #define PROBLEM "https://judge.u-aizu.ac.jp/onlinejudge/description.jsp?id=3314" #define ERROR 1e-6 #line 2 "cpp/matrix.hpp" #include <vector> #include <string> #include <algorithm> #include <valarray> #include <cassert> #include <type_traits> namespace matrix { template <typename T> struct OperatorPropertyDefault { constexpr static T zero() { return T(0); } constexpr static T add(const T &a, const T &b) { return a + b; } constexpr static T neg(const T &a) { return -a; } constexpr static T one() { return T(1); } constexpr static T mul(const T &a, const T &b) { return a * b; } constexpr static T inv(const T &a) { return T(1) / a; } }; } /** * @brief 行列 * @tparam T 型 行列(グリッド)の要素となるintやchar * @tparam OperatorProperty 行列の要素の演算を定義する構造体 0,1と+,*なら省略可 * * @note * OperatorPropertyの例(整数のxorとandによる環) * @code * struct XorOperatorProperty { * constexpr static int zero() { return 0; } * constexpr static int add(const int &a, const int &b) { return a ^ b; } * constexpr static int neg(const int &a) { return a; } * constexpr static int one() { return 1; } * constexpr static int mul(const int &a, const int &b) { return a & b; } * }; * @endcode * constexprである必要はなく、またinvなど使わないものは定義しなくてもよい(必要なものがなかったらコンパイルエラーが発生する) */ template<class T, class OperatorProperty = matrix::OperatorPropertyDefault<T>> struct Matrix { int n, m; std::vector<std::vector<T>> v; /** * @brief コンストラクタ * @param v 行列(グリッド)の元となる vector<string> や vector<vector<T>> * @return Matrix */ template <typename Iterable> Matrix(const std::vector<Iterable>& v_) noexcept : n(v_.size()), m(v_.size() == 0 ? 0 : v_[0].size()) { v.resize(n); for(int i = 0; i < n; i++) { v[i].assign(v_[i].begin(), v_[i].end()); } } /** * @brief コンストラクタ * @param _n 行列(グリッド)の行数 * @param _m 行列(グリッド)の列数 * @param _val 行列(グリッド)の要素の初期値 * @return Matrix */ Matrix(int _n, int _m, T _val = OperatorProperty::zero()) : n(_n), m(_m), v(n, std::vector<T>(m, _val)) {} auto begin() noexcept {return v.begin();} auto end() noexcept {return v.end();} /** * @brief 行列(グリッド)の行数 * @return size_t */ [[nodiscard]] size_t size() const {return v.size();} std::vector<T>& operator [] (int i) {return v[i];} const std::vector<T>& operator [] (int i) const {return v[i];} Matrix<T>& operator = (const std::vector<std::vector<T>> &A) noexcept { n = A.size(); m = (n == 0 ? 0 : A[0].size()); v = A; return *this; } bool operator == (const Matrix<T> &A) noexcept { return this->v == A.v; } /** * @brief 転置 * @return Matrix */ [[nodiscard]] Matrix transpose() noexcept { if(n == 0) return Matrix(v); std::vector<std::vector<T>> ret(m); for(int i = 0; i < m; i ++) { ret[i].resize(n); for(int j = 0; j < n; j ++) ret[i][j] = v[j][i]; } return Matrix(ret); } /** * @brief 左右反転 * @return Matrix */ [[nodiscard]] Matrix rev_lr() noexcept { std::vector<std::vector<T>> ret = v; for(int i = 0; i < n; i ++) std::reverse(ret[i].begin(), ret[i].end()); return Matrix(ret); } /** * @brief 上下反転 * @return Matrix */ [[nodiscard]] Matrix rev_ud() noexcept { std::vector<std::vector<T>> ret = v; reverse(ret.begin(), ret.end()); return Matrix(ret); } /** * @brief 時計周りに90度回転 * @param k 回転する回数 * @return Matrix */ [[nodiscard]] Matrix rotate(int k) noexcept { k %= 4; if(k == 0) return *this; if(k < 0) k += 4; if(k == 2) return this->rev_lr().rev_ud(); std::vector<std::vector<T>> ret(m); if(k == 1) { for(int i = 0; i < m; i ++) { ret[i].resize(n); for(int j = 0; j < n; j ++) ret[i][j] = v[n - j - 1][i]; } } else { for(int i = 0; i < m; i ++) { ret[i].resize(n); for(int j = 0; j < n; j ++) ret[i][j] = v[j][m - i - 1]; } } return Matrix(ret); } /** * @brief (i, j)を((i + dy) mod n, (j + dx) mod m)に移動 * @return Matrix */ [[nodiscard]] Matrix shift(int dy, int dx) noexcept { std::vector<std::vector<T>> ret = v; for(int i = 0, ni = dy; i < n; i ++, ni ++) { if(ni >= n) ni = 0; for(int j = 0, nj = dx; j < m; j ++, nj ++) { if(nj >= m) nj = 0; ret[ni][nj] = v[i][j]; } } return Matrix(ret); } /** * @brief 左にk回シフト * @return Matrix */ [[nodiscard]] Matrix shift_l(int k) noexcept { return this->shift(0, -k); } /** * @brief 右にk回シフト * @return Matrix */ [[nodiscard]] Matrix shift_r(int k) noexcept { return this->shift(0, k); } /** * @brief 上にk回シフト * @return Matrix */ [[nodiscard]] Matrix shift_u(int k) noexcept { return this->shift(-k, 0); } /** * @brief 下にk回シフト * @return Matrix */ [[nodiscard]] Matrix shift_d(int k) noexcept { return this->shift(k, 0); } /** * @brief グリッドをvector<string>で返す * @return std::vector<std::string> */ [[nodiscard]] std::vector<std::string> vstr() noexcept { std::vector<std::string> ret(n); for(int i = 0; i < n; i ++) { ret[i].assign(v[i].begin(), v[i].end()); } return ret; } /** * @brief グリッドのj列目を返す * @param j 返す列番号(0-indexed) * @return std::vector<T> */ [[nodiscard]] std::vector<T> col(int j) noexcept { std::vector<T> ret(n); for(int i = 0; i < n; i ++) { ret[i] = v[i][j]; } return ret; } /** * @brief グリッドのi行目をstringで返す * @param i 返す行番号(0-indexed) * @return std::string */ [[nodiscard]] std::string str(int i) noexcept { std::string ret; ret.assign(v[i].begin(), v[i].end()); return ret; } /** * @brief 保持している行列に行列Bを足す * @param B 足す行列 * @return @c *this */ Matrix &operator+=(const Matrix &B) { if(n == 0) return (*this); assert(n == B.size() && m == B[0].size()); for(int i = 0; i < n; i++) for(int j = 0; j < m; j++) (*this)[i][j] = OperatorProperty::add((*this)[i][j], B[i][j]); return (*this); } /** * @brief 保持している行列から行列Bを引く * @param B 引く行列 * @return @c *this */ Matrix &operator-=(const Matrix &B) { if(n == 0) return (*this); assert(n == B.size() && m == B[0].size()); for(int i = 0; i < n; i++) for(int j = 0; j < m; j++) (*this)[i][j] = OperatorProperty::add((*this)[i][j], OperatorProperty::neg(B[i][j])); return (*this); } /** * @brief 保持している行列に行列Bを掛ける * @param B 掛ける行列 * @return @c *this */ Matrix &operator*=(const Matrix &B) { int p = B[0].size(); Matrix<T> C(n, p); for(int i = 0; i < n; i ++) { for(int k = 0; k < m; k ++) { for(int j = 0; j < p; j ++) { C[i][j] = OperatorProperty::add(C[i][j], OperatorProperty::mul((*this)[i][k], B[k][j])); } } } v.swap(C.v); m = p; return (*this); } /** * @brief 保持している行列のk乗を求める * @param k 指数 * @return Matrix */ [[nodiscard]] Matrix pow(long long k) const { Matrix<T> A = *this, B(n, n); for(int i = 0; i < n; i ++) B[i][i] = OperatorProperty::one(); while(k > 0) { if(k & 1) B *= A; A *= A; k >>= 1; } return B; } [[nodiscard]] Matrix operator+(const Matrix &B) const { return (Matrix(*this) += B); } [[nodiscard]] Matrix operator-(const Matrix &B) const { return (Matrix(*this) -= B); } [[nodiscard]] Matrix operator*(const Matrix &B) const { return (Matrix(*this) *= B); } /** * @brief 行列Aと列ベクトルBの積 * @param A Matrix<T> * @param B vector<T> * @return vector<T> 列ベクトル */ [[nodiscard]] friend std::vector<T> operator*(const Matrix &A, const std::vector<T> &B) { std::vector<T> ret(A.n, 0); for(int i = 0; i < A.n; i ++) { for(int j = 0; j < A.m; j ++) { ret[i] = OperatorProperty::add(ret[i], OperatorProperty::mul(A[i][j], B[j])); } } return ret; } /** * @brief 行ベクトルAと行列Bの積 * @param A vector<T> * @param B Matrix<T> * @return vector<T> 行ベクトル */ [[nodiscard]] friend std::vector<T> operator*(const std::vector<T> &A, const Matrix &B) { std::vector<T> ret(B.m, 0); for(int i = 0; i < B.n; i ++) { for(int j = 0; j < B.m; j ++) { ret[j] = OperatorProperty::add(ret[j], OperatorProperty::mul(A[i], B[i][j])); } } return ret; } /** * @brief 行列式 * @return 行列式 */ [[nodiscard]] T det() const { assert(n == m); if(n == 0) return T(1); if constexpr(std::is_same_v<OperatorProperty, matrix::OperatorPropertyDefault<T>>) { std::vector A(n, std::valarray(T(0), n)); for(int i = 0; i < n; i ++) for(int j = 0; j < n; j ++) A[i][j] = this->v[i][j]; return forward_elimination(A); } else { auto A = this->v; return forward_elimination(A); } } /** * @brief 逆行列 * @return 逆行列 */ [[nodiscard]] Matrix inv() const { assert(n == m); if(n == 0) return Matrix(n, n); if constexpr(std::is_same_v<OperatorProperty, matrix::OperatorPropertyDefault<T>>) { std::vector A(n, std::valarray(T(0), n+n)); for(int i = 0; i < n; i ++) { for(int j = 0; j < n; j ++) A[i][j] = this->v[i][j]; A[i][n+i] = T(1); } assert(forward_elimination(A) != T(0)); for(int i = n - 1; i >= 0; i --) { for(int j = i - 1; j >= 0; j --) { A[j] -= A[i] * A[j][i]; } } Matrix<T> ret(n, n); for(int i = 0; i < n; i ++) for(int j = 0; j < n; j ++) ret[i][j] = A[i][n+j]; return ret; } else { std::vector A(n, std::vector<T>(n+n, OperatorProperty::zero())); for(int i = 0; i < n; i ++) { for(int j = 0; j < n; j ++) A[i][j] = this->v[i][j]; A[i][n+i] = OperatorProperty::one(); } assert(forward_elimination(A) != T(0)); for(int i = n - 1; i >= 0; i --) { for(int j = i - 1; j >= 0; j --) { for(int k = n; k < n+n; k ++) { A[j][k] = OperatorProperty::add(A[j][k], OperatorProperty::neg(OperatorProperty::mul(A[i][k], A[j][i]))); } } } Matrix<T> ret(n, n); for(int i = 0; i < n; i ++) for(int j = 0; j < n; j ++) ret[i][j] = A[i][n+j]; return ret; } } private: /** * @brief ガウスの消去法の前進消去を行って上三角行列を作り、行列式を返す * @param A 行列 * @return 行列式 * @note * rank(A) < nの場合は0を返す * 正方行列ではない場合、0以外が残る左からn個の列を使って行列式を計算する */ T forward_elimination(std::vector<std::valarray<T>>& A) const { std::vector<int> pivot_col(n, 0); T d(1); for(int i = 0; i < n; i ++) { if(i - 1 >= 0) pivot_col[i] = pivot_col[i - 1] + 1; while(pivot_col[i] < m) { int pivot = i; if constexpr(std::is_floating_point_v<T>) { for(int j = i + 1; j < n; j ++) if(std::abs(A[j][pivot_col[i]]) > std::abs(A[pivot][pivot_col[i]])) pivot = j; if(std::abs(A[pivot][pivot_col[i]]) < 1e-9) { pivot_col[i] ++; continue; } } else { while(pivot < n && A[pivot][pivot_col[i]] == T(0)) pivot ++; if(A[pivot][pivot_col[i]] == T(0)) { pivot_col[i] ++; continue; } } if(pivot != i) { std::swap(A[i], A[pivot]); d *= -T(1); } break; } if(pivot_col[i] == m) return T(0); T scale = A[i][pivot_col[i]]; d *= scale; A[i] /= scale; for(int j = i + 1; j < n; j ++) A[j] -= A[i] * A[j][pivot_col[i]]; } return d; } /** * @brief ガウスの消去法の前進消去を行って上三角行列を作り、行列式を返す * @param A 行列 * @return 行列式 * @note * rank(A) < nの場合は0を返す * 正方行列ではない場合、0以外が残る左からn個の列を使って行列式を計算する */ T forward_elimination(std::vector<std::vector<T>>& A) const { std::vector<int> pivot_col(n, 0); T d = OperatorProperty::one(); for(int i = 0; i < n; i ++) { if(i - 1 >= 0) pivot_col[i] = pivot_col[i - 1] + 1; while(pivot_col[i] < m) { int pivot = i; while(pivot < n && A[pivot][pivot_col[i]] == OperatorProperty::zero()) pivot ++; if(A[pivot][pivot_col[i]] == OperatorProperty::zero()) { pivot_col[i] ++; continue; } if(pivot != i) { std::swap(A[i], A[pivot]); d = OperatorProperty::neg(d); } break; } if(pivot_col[i] == m) return T(0); T scale = A[i][pivot_col[i]]; d = OperatorProperty::mul(d, scale); for(int j = pivot_col[i]; j < m; j ++) A[i][j] = OperatorProperty::mul(A[i][j], OperatorProperty::inv(scale)); for(int j = i + 1; j < n; j ++) { T scale = A[j][pivot_col[i]]; for(int k = pivot_col[i]; k < m; k ++) { A[j][k] = OperatorProperty::add(A[j][k], OperatorProperty::neg(OperatorProperty::mul(A[i][k], scale))); } } } return d; } }; #line 2 "cpp/vector.hpp" #line 4 "cpp/vector.hpp" #include <array> #line 6 "cpp/vector.hpp" #include <cmath> #include <initializer_list> #include <istream> #include <numeric> #include <ostream> #include <stack> #include <tuple> #line 15 "cpp/vector.hpp" /** * @brief 幾何学としてのベクトル * * @tparam T 型 省略したらdouble * @tparam Dim 次元 省略したら2 */ template <typename T = double, int Dim = 2, std::enable_if_t<std::is_scalar_v<T> && (Dim > 0)>* = nullptr> struct Vector { std::array<T, Dim> v; //!< ベクトルの成分表示 /** * @brief デフォルトコンストラクタ * ゼロベクトル */ constexpr Vector() noexcept : v() {} /** * @brief 可変長引数によるコンストラクタ * * @tparam Args */ template <typename... Args> constexpr Vector(Args... args) noexcept : v{args...} {} /** * @brief i番目の成分を返す * * @param i * @return T& */ constexpr T& operator[](int i) noexcept { return v[i]; } /** * @brief i番目の成分を返す * * @param i * @return T& */ constexpr const T& operator[](int i) const noexcept { return v[i]; } /** * @brief 加算代入演算子 * * @param rhs * @return Vector& */ constexpr Vector& operator+=(const Vector& rhs) noexcept { for(int i = 0; i < Dim; i++) v[i] += rhs[i]; return *this; } /** * @brief 減算代入演算子 * * @param rhs * @return Vector& */ constexpr Vector& operator-=(const Vector& rhs) noexcept { for(int i = 0; i < Dim; i++) v[i] -= rhs.v[i]; return *this; } /** * @brief スカラー倍代入演算子 * * @param coef * @return Vector& */ constexpr Vector& operator*=(const T& coef) noexcept { for(int i = 0; i < Dim; i++) v[i] *= coef; return *this; } /** * @brief スカラーの逆数倍代入演算子 * * @param coef * @return Vector& */ Vector& operator/=(const T& coef) { for(int i = 0; i < Dim; i++) { if constexpr(std::is_integral_v<T>) { assert(v[i] % coef == 0 && "Vector::operator/= : coef must be a divisor of all elements"); } v[i] /= coef; } return *this; } /** * @brief 単項プラス演算子 * * @return Vector */ [[nodiscard]] constexpr Vector operator+() const noexcept { return *this; } /** * @brief 単項マイナス演算子 * * @return Vector */ [[nodiscard]] constexpr Vector operator-() const noexcept { return *this * (-1); } /** * @brief 加算演算子 * * @param lhs * @param rhs * @return Vector */ [[nodiscard]] friend constexpr Vector operator+(const Vector& lhs, const Vector& rhs) noexcept { return std::move(Vector(lhs) += rhs); } /** * @brief 減算演算子 * * @param lhs * @param rhs * @return Vector */ [[nodiscard]] friend constexpr Vector operator-(const Vector& lhs, const Vector& rhs) noexcept { return std::move(Vector(lhs) -= rhs); } /** * @brief スカラー倍演算子 * * @param lhs * @param coef * @return Vector */ [[nodiscard]] friend constexpr Vector operator*(const Vector& lhs, const T& coef) noexcept { return std::move(Vector(lhs) *= coef); } /** * @brief スカラー倍演算子 * * @param coef * @param rhs * @return Vector */ [[nodiscard]] friend constexpr Vector operator*(const T& coef, const Vector& rhs) noexcept { return std::move(Vector(rhs) *= coef); } /** * @brief スカラーの逆数倍演算子 * * @param lhs * @param coef * @return Vector */ [[nodiscard]] friend Vector operator/(const Vector& lhs, const T& coef) { return std::move(Vector(lhs) /= coef); } /** * @brief 等価演算子 * * @param lhs * @param rhs * @return bool */ [[nodiscard]] friend constexpr bool operator==(const Vector& lhs, const Vector& rhs) noexcept { return lhs.v == rhs.v; } /** * @brief 非等価演算子 * * @param lhs * @param rhs * @return bool */ [[nodiscard]] friend constexpr bool operator!=(const Vector& lhs, const Vector& rhs) noexcept { return lhs.v != rhs.v; } /** * @brief 小なり演算子 * * @param lhs * @param rhs * @return bool */ [[nodiscard]] friend constexpr bool operator<(const Vector& lhs, const Vector& rhs) noexcept { return lhs.v < rhs.v; } /** * @brief 大なり演算子 * * @param lhs * @param rhs * @return bool */ [[nodiscard]] friend constexpr bool operator>(const Vector& lhs, const Vector& rhs) noexcept { return lhs.v > rhs.v; } /** * @brief 小なりイコール演算子 * * @param lhs * @param rhs * @return bool */ [[nodiscard]] friend constexpr bool operator<=(const Vector& lhs, const Vector& rhs) noexcept { return lhs.v <= rhs.v; } /** * @brief 大なりイコール演算子 * * @param lhs * @param rhs * @return bool */ [[nodiscard]] friend constexpr bool operator>=(const Vector& lhs, const Vector& rhs) noexcept { return lhs.v >= rhs.v; } /** * @brief 偏角ソートのファンクタ * * 二次元限定、反時計回り */ struct ArgSortComp { template <std::enable_if_t<Dim == 2>* = nullptr> bool operator()(const Vector& lhs, const Vector& rhs) { int l_half = lhs[1] < 0 || (lhs[1] == 0 && lhs[0] < 0); int r_half = rhs[1] < 0 || (rhs[1] == 0 && rhs[0] < 0); if(l_half != r_half) return l_half < r_half; return rhs[0] * lhs[1] < lhs[0] * rhs[1]; } }; /** * @brief 入力ストリームからの読み込み * * @tparam CharT 入力ストリームの文字型 * @tparam Traits 入力ストリームの文字型特性 * @param is * @param rhs * @return std::basic_istream<CharT, Traits>& */ template <class CharT, class Traits> friend std::basic_istream<CharT, Traits>& operator>>(std::basic_istream<CharT, Traits>& is, Vector& rhs) { for(int i = 0; i < Dim; i++) is >> rhs.v[i]; return is; } /** * @brief 出力ストリームへの書き込み * * @tparam CharT 出力ストリームの文字型 * @tparam Traits 出力ストリームの文字型特性 * @param is * @param rhs * @return std::basic_ostream<CharT, Traits>& */ template <class CharT, class Traits> friend std::basic_ostream<CharT, Traits>& operator<<(std::basic_ostream<CharT, Traits>& os, const Vector& rhs) { for(int i = 0; i < Dim; i++) { if(i != 0) os << CharT(' '); os << rhs.v[i]; } return os; } /** * @brief 内積 * * @param lhs * @param rhs * @return T */ friend constexpr T dot(const Vector& lhs, const Vector& rhs) noexcept { T ret = 0; for(int i = 0; i < Dim; i++) ret += lhs[i] * rhs[i]; return ret; } /** * @brief 絶対値の2乗 * * @return T */ constexpr T squared_norm() const noexcept { return dot(*this, *this); } /** * @brief 絶対値 * * @return double */ constexpr double abs() const noexcept { return std::sqrt(squared_norm()); } }; /** * @brief 二次元ベクトルどうしの外積(平行四辺形の符号付き面積) * * @param lhs * @param rhs * @tparam T 座標の型 * @return T */ template <typename T> constexpr T cross(const Vector<T, 2>& lhs, const Vector<T, 2>& rhs) noexcept { return lhs[0] * rhs[1] - lhs[1] * rhs[0]; } /** * @brief 三次元ベクトルどうしの外積 * * @param lhs * @param rhs * @tparam T 座標の型 * @return Vector<T, 3> */ template <typename T> constexpr Vector<T, 3> cross(const Vector<T, 3>& lhs, const Vector<T, 3>& rhs) noexcept { Vector<T, 3> ret; ret[0] = lhs[1] * rhs[2] - lhs[2] * rhs[1]; ret[1] = lhs[2] * rhs[0] - lhs[0] * rhs[2]; ret[2] = lhs[0] * rhs[1] - lhs[1] * rhs[0]; return ret; } /** * @brief 線分の交差判定 * * @param p1 1本目の線分の端点1 * @param p2 1本目の線分の端点2 * @param q1 2本目の線分の端点1 * @param q2 2本目の線分の端点2 * @tparam T 座標の型 * @return std::pair<bool, Vector<T, 2>> firstは共有点の有無、secondは共有点の1例 */ template <typename T> constexpr std::pair<bool, Vector<T, 2>> segment_intersect(const Vector<T, 2>& p1, const Vector<T, 2>& p2, const Vector<T, 2>& q1, const Vector<T, 2>& q2) { assert(p1 != p2 && q1 != q2 && "segment_intersect: degenerate segment"); T q1_cross = cross(p2 - p1, q1 - p1); int q1_section = (q1_cross > 0) - (q1_cross < 0); // 直線p1p2に対してq1がどの位置にあるか T q2_cross = cross(p2 - p1, q2 - p1); int q2_section = (q2_cross > 0) - (q2_cross < 0); // 直線p1p2に対してq2がどの位置にあるか T p1_cross = cross(q2 - q1, p1 - q1); int p1_section = (p1_cross > 0) - (p1_cross < 0); // 直線q1q2に対してp1がどの位置にあるか T p2_cross = cross(q2 - q1, p2 - q1); int p2_section = (p2_cross > 0) - (p2_cross < 0); // 直線q1q2に対してp2がどの位置にあるか if(q1_section == 0 && q2_section == 0) { // 4点が同一直線上にある場合 if(dot(q1-p1, q2-p1) <= 0) return std::make_pair(true, p1); if(dot(q1-p2, q2-p2) <= 0) return std::make_pair(true, p2); if(dot(p1-q1, p2-q1) <= 0) return std::make_pair(true, q1); return std::make_pair(false, Vector<T, 2>()); } if(q1_section * q2_section > 0 || p1_section * p2_section > 0) return std::make_pair(false, Vector<T, 2>()); T area = cross(p2 - p1, q2 - q1); // 4点を頂点とする四角形の符号付き面積 T partial_area = p1_cross; // 三角形q1q2p1の符号付き面積 Vector<T, 2> vp12 = p2 - p1; // ベクトルp1p2 if constexpr(std::is_integral_v<T>) { T g = std::gcd(area, partial_area); area /= g; partial_area /= g; } return std::make_pair(true, p1 + vp12 * partial_area / area); } /** * @brief 多角形の符号付き面積の2倍 * * @tparam T 座標の型 * @param polygon 頂点の座標 * @return T 面積の2倍(反時計回りなら正、時計回りなら負) */ template <typename T> T polygon_area_doubled(const std::vector<Vector<T, 2>>& polygon) { T ret = 0; for(int i = 0; i < (int)polygon.size(); i++) { int j = i+1; if(j == (int)polygon.size()) j = 0; ret += cross(polygon[i], polygon[j]); } return ret; } /** * @brief 多角形の面積 * * @tparam T 座標の型 * @param polygon 頂点の座標(順番、反時計回りか時計回りかは問わない) * @return double 面積 */ template <typename T> double polygon_area(const std::vector<Vector<T, 2>>& polygon) { return std::abs(polygon_area_doubled(polygon)) / 2.; } /** * @brief 多角形の凸性判定 * * @tparam T 座標の型 * @param polygon 頂点の座標(反時計回り) * @return true 凸 * @return false 凹 */ template <typename T> bool polygon_is_convex(const std::vector<Vector<T, 2>>& polygon) { int n = polygon.size(); for(int i = 0; i < n; i++) { int j = i+1; if(j == n) j = 0; int k = j+1; if(k == n) k = 0; if(cross(polygon[j] - polygon[i], polygon[k] - polygon[j]) < 0) return false; } return true; } /** * @brief 点の多角形内包含判定 * * @tparam T 座標の型 * @param polygon 頂点の座標(反時計回り) * @param p 点の座標 * @return int 0: 外部, 1: 辺上, 2: 内部 */ template <typename T> int polygon_contains(const std::vector<Vector<T, 2>>& polygon, const Vector<T, 2>& p) { bool in = false; for(int i = 0; i < (int)polygon.size(); i++) { int j = i+1; if(j == (int)polygon.size()) j = 0; Vector<T> v1 = polygon[i] - p, v2 = polygon[j] - p; if(v1[1] > v2[1]) std::swap(v1, v2); T c = cross(v1, v2); if(v1[1] <= 0 && v2[1] > 0 && c < 0) in = !in; if(c == 0 && dot(v1, v2) <= 0) return 1; } return in ? 2 : 0; } /** * @brief 多角形の半凸包 * 与えられた頂点リストの順番を保って反時計回りに凸包を構成する * xの昇順にソートされていれば下凸包、xの降順にソートされていれば上凸包が得られる * * @tparam T 座標の型 * @param points 頂点リスト * @param include_straight 内角が180度の頂点を含むかどうか * @return std::vector<Vector<T, 2>> 半凸包の頂点の座標(反時計回り) */ template <typename T> std::vector<Vector<T, 2>> select_convex(const std::vector<Vector<T, 2>>& points, bool include_straight = false) { std::vector<Vector<T, 2>> ret; for(auto& p : points) { while((int)ret.size() >= 2) { T c = cross(ret.back() - ret[(int)ret.size()-2], p - ret.back()); if(c > 0 || (c == 0 && include_straight)) break; ret.pop_back(); } ret.push_back(p); } return ret; } /** * @brief 多角形の凸包 * * @tparam T 座標の型 * @param points 頂点リスト * @param include_straight 内角が180度の頂点を含むかどうか * @return std::vector<Vector<T, 2>> 凸包の頂点の座標(反時計回り) */ template <typename T> std::vector<Vector<T, 2>> convex_hull(const std::vector<Vector<T, 2>>& _points, bool include_straight = false) { std::vector<Vector<T, 2>> points = _points; std::sort(points.begin(), points.end()); std::vector<Vector<T, 2>> ret = select_convex(points, include_straight); std::reverse(points.begin(), points.end()); std::vector<Vector<T, 2>> tmp = select_convex(points, include_straight); for(int i = 1; i < (int)tmp.size()-1; i++) ret.push_back(tmp[i]); return ret; } /** * @brief 最近点対 * * @tparam T 座標の型 * @param points 頂点リスト * @return std::tuple<T, int, int> 最近点対の距離の2乗、最近点対のインデックス */ template <typename T> std::tuple<T, int, int> closest_point_pair_squred(const std::vector<Vector<T, 2>>& points) { std::vector<int> sorted_idx(points.size()); std::iota(sorted_idx.begin(), sorted_idx.end(), 0); std::sort(sorted_idx.begin(), sorted_idx.end(), [&](int i, int j) { return points[i][0] < points[j][0]; }); std::vector<int> left(1, 0); // 左端 std::vector<int> right(1, points.size()); // 右端 std::vector<int> mid(1, points.size()/2); // 中央 std::vector<int> par(1, -1); // 親 std::vector<T> min_dist_squared(1, std::numeric_limits<T>::max()); // 最小距離の2乗 std::vector<std::pair<int, int>> min_dist_pair(1, {-1, -1}); // 最小距離の点対 std::stack<int> stk; stk.push(~0); stk.push(0); while(!stk.empty()) { int u = stk.top(); stk.pop(); if(u >= 0) { // 行きがけ if(left[u] + 1 < mid[u]) { int v = left.size(); left.push_back(left[u]); right.push_back(mid[u]); mid.push_back((left[u] + mid[u]) / 2); par.push_back(u); min_dist_squared.push_back(std::numeric_limits<T>::max()); min_dist_pair.push_back({-1, -1}); stk.push(~v); stk.push(v); } if(mid[u] + 1 < right[u]) { int v = left.size(); left.push_back(mid[u]); right.push_back(right[u]); mid.push_back((mid[u] + right[u]) / 2); par.push_back(u); min_dist_squared.push_back(std::numeric_limits<T>::max()); min_dist_pair.push_back({-1, -1}); stk.push(~v); stk.push(v); } } else { // 帰りがけ u = ~u; std::vector<int> cand; for(int i = left[u]; i < right[u]; i++) { T dx = points[sorted_idx[i]][0] - points[sorted_idx[mid[u]]][0]; if(dx * dx < min_dist_squared[u]) cand.push_back(i); } std::sort(cand.begin(), cand.end(), [&](int i, int j) { return points[sorted_idx[i]][1] < points[sorted_idx[j]][1]; }); for(int i = 0; i < (int)cand.size(); i++) { for(int j = i+1; j < (int)cand.size(); j++) { T dx = points[sorted_idx[cand[j]]][0] - points[sorted_idx[cand[i]]][0]; T dy = points[sorted_idx[cand[j]]][1] - points[sorted_idx[cand[i]]][1]; if(dy * dy >= min_dist_squared[u]) break; T d = dx * dx + dy * dy; if(d < min_dist_squared[u]) { min_dist_squared[u] = d; min_dist_pair[u] = {sorted_idx[cand[i]], sorted_idx[cand[j]]}; } } } if(par[u] != -1 && min_dist_squared[u] < min_dist_squared[par[u]]) { min_dist_squared[par[u]] = min_dist_squared[u]; min_dist_pair[par[u]] = min_dist_pair[u]; } } } return {min_dist_squared[0], min_dist_pair[0].first, min_dist_pair[0].second}; } /** * @brief 最近点対 * * @tparam T 座標の型 * @param points 頂点リスト * @return std::tuple<double, int, int> 最近点対の距離、最近点対のインデックス */ template <typename T> std::tuple<double, int, int> closest_point_pair(const std::vector<Vector<T, 2>>& points) { auto [d2, i, j] = closest_point_pair_squred(points); return {std::sqrt(d2), i, j}; } #line 6 "test/aoj-3314.test.cpp" #include <iomanip> #include <iostream> int main() { // https://qiita.com/KowerKoint/items/e697f896c749f756235f double phi = (1 + std::sqrt(5)) / 2; std::vector<Vector<double, 3>> base = { {0., 1., phi}, {phi, 0., 1.}, {1., phi, 0.}, {-1., phi, 0.}, {-phi, 0., 1.}, {0., -1., phi}, {phi, 0., -1.}, {0., 1., -phi}, {-phi, 0., -1.}, {-1., -phi, 0.}, {1., -phi, 0.}, {0., -1., -phi} }; Vector<double, 3> base_g = (base[0] + base[1] + base[2]) / 3; double k = base_g.abs() * (base[1]-base[0]).abs() / (cross(base[1]-base[0], base[2]-base[0])).abs(); Matrix<double> base_abc(3, 3); for(int i = 0; i < 3; i++) base_abc[i].assign(base[i].v.begin(), base[i].v.end()); Vector<double, 3> a, b, c; std::cin >> a >> b >> c; auto g = (a + b + c) / 3; auto t = cross((b - a), (c - a)) * (-k / (b - a).abs()) + g; Matrix<double> trans_abc(3, 3); for(int j = 0; j < 3; j++) trans_abc[0][j] = a[j] - t[j]; for(int j = 0; j < 3; j++) trans_abc[1][j] = b[j] - t[j]; for(int j = 0; j < 3; j++) trans_abc[2][j] = c[j] - t[j]; auto s = base_abc.inv() * trans_abc; std::cout << std::fixed << std::setprecision(10); int n; std::cin >> n; while(n--) { int v; std::cin >> v; v--; auto p = std::vector<double>(base[3+v].v.begin(), base[3+v].v.end()) * s; std::cout << Vector<double, 3>{p[0], p[1], p[2]} + t << std::endl; } }